petsc-dev 2014-02-02
Report Typos and Errors

Krylov Methods - KSP: : Examples

The scalable linear equations solvers (KSP) component provides an easy-to-use interface to the combination of a Krylov subspace iterative method and a preconditioner (in the KSP and PC components, respectively) or a sequential direct solver. KSP users can set various Krylov subspace options at runtime via the options database (e.g., -ksp_type cg ). KSP users can also set KSP options directly in application by directly calling the KSP routines listed below (e.g., KSPSetType() ). KSP components can be used directly to create and destroy solvers; this is not needed for users but is intended for library developers.

Beginner - Basic usage
KSPBCGS KSP_DIVERGED_BREAKDOWN KSPPGMRES
KSPBCGSL KSP_DIVERGED_DTOL KSPPIPECG
KSPBICG KSP_DIVERGED_INDEFINITE_PC KSPPIPECR
KSPCG KSP_DIVERGED_ITS KSPPREONLY
KSPCGNE KSP_DIVERGED_NONSYMMETRIC KSPReset
KSPCGS KSPFBCGS KSPRICHARDSON
KSPCGType KSPFBCGSR KSPSetComputeInitialGuess
KSPCHEBYSHEV KSPFGMRES KSPSetComputeOperators
KSP_CONVERGED_ATOL KSPGCR KSPSetComputeRHS
KSP_CONVERGED_ITERATING KSPGMRES KSPSetFromOptions
KSP_CONVERGED_ITS KSPGROPPCG KSPSetInitialGuessNonzero
KSPConvergedReason KSP KSPSetOperators
KSP_CONVERGED_RTOL KSPIBCGS KSPSolve
KSPCreate KSPLCD KSPSYMMLQ
KSPCR KSPLGMRES KSPTCQMR
KSPDestroy KSPLSQR KSPTFQMR
KSPDGMRES KSPMINRES KSPType
KSP_DIVERGED_BREAKDOWN_BICG KSPMonitorSet KSPView
Intermediate - Setting options for algorithms and data structures
KSPBCGSLSetEll KSPGetMonitorContext KSPMonitorLGTrueResidualNormDestroy
KSPBCGSLSetPol KSPGetOperators KSPMonitorRange
KSPBCGSLSetUsePseudoinverse KSPGetOperatorsSet KSPMonitorSingularValue
KSPBCGSLSetXRes KSPGetPCSide KSPMonitorSolution
KSPCGSetType KSPGetResidualNorm KSPMonitorTrueResidualMaxNorm
KSPCGUseSingleReduction KSPGetTolerances KSPMonitorTrueResidualNorm
KSPChebyshevEstEigSetRandom KSPGetType KSPPythonSetType
KSPChebyshevSetEigenvalues KSPGMRESClassicalGramSchmidtOrthogonalization KSPRichardsonSetScale
KSPChebyshevSetEstimateEigenvalues KSPGMRESGetCGSRefinementType KSPRichardsonSetSelfScale
KSPConvergedDefaultCreate KSPGMRESGetOrthogonalization KSPSetApplicationContext
KSPConvergedDefaultDestroy KSPGMRESGetRestart KSPSetDiagonalScaleFix
KSPConvergedDefault KSPGMRESModifiedGramSchmidtOrthogonalization KSPSetDiagonalScale
KSPConvergedDefaultSetUIRNorm KSPGMRESMonitorKrylov KSPSetDMActive
KSPConvergedDefaultSetUMIRNorm KSPGMRESSetCGSRefinementType KSPSetDM
KSPFGMRESModifyPCKSP KSPGMRESSetHapTol KSPSetErrorIfNotConverged
KSPFGMRESModifyPCNoChange KSPGMRESSetOrthogonalization KSPSetPCSide
KSPFGMRESSetModifyPC KSPGMRESSetPreAllocateVectors KSPSetTolerances
KSPGCRSetModifyPC KSPGMRESSetRestart KSPSetType
KSPGetApplicationContext KSPLoad KSPSPECEST
KSPGetConvergedReason KSPLSQRDefaultConverged MatCreateSchurComplement
KSPGetDiagonalScaleFix KSPLSQRMonitorDefault MatSchurComplementGetKSP
KSPGetDiagonalScale KSPMonitorCancel MatSchurComplementGetSubmatrices
KSPGetDM KSPMonitorDefault MatSchurComplementSet
KSPGetErrorIfNotConverged KSPMonitorLGResidualNormCreate MatSchurComplementUpdate
KSPGetInitialGuessNonzero KSPMonitorLGResidualNormDestroy
KSPGetIterationNumber KSPMonitorLGTrueResidualNormCreate
Advanced - Setting more advanced options and customization
DMKSPGetComputeInitialGuess KSPGetResidualHistory KSPQCGGetTrialStepNorm
DMKSPGetComputeOperators KSPGetVecs KSPQCGSetTrustRegionRadius
DMKSPGetComputeRHS KSPGLTRGetLambda KSPRegisterAll
DMKSPSetComputeInitialGuess KSPGLTRGetMinEig KSPRegister
DMKSPSetComputeOperators KSPGLTRGetNormD KSPSetCheckNormIteration
DMKSPSetComputeRHS KSPGLTRGetObjFcn KSPSetComputeEigenvalues
KSPAppendOptionsPrefix KSPGLTRSetRadius KSPSetComputeSingularValues
KSPBuildResidual KSP_GMRES_CGS_REFINE_IFNEEDED KSPSetConvergenceTest
KSPBuildSolution KSPGMRESCGSRefinementType KSPSetFischerGuess
KSPComputeEigenvaluesExplicitly KSP_GMRES_CGS_REFINE_NEVER KSPSetInitialGuessKnoll
KSPComputeEigenvalues KSPMatRegisterAll KSPSetLagNorm
KSPComputeExplicitOperator KSPMonitorDynamicTolerance KSPSetNormType
KSPComputeExtremeSingularValues KSPMonitorSAWs KSPSetNullSpace
KSPConvergedSkip KSPNASHGetNormD KSPSetOptionsPrefix
KSPFischerGuessCreate KSPNASHGetObjFcn KSPSetResidualHistory
KSPGetComputeEigenvalues KSPNASHSetRadius KSPSetUpOnBlocks
KSPGetComputeSingularValues KSP_NORM_NATURAL KSPSetUseFischerGuess
KSPGetConvergenceContext KSP_NORM_NONE KSPSTCGGetNormD
KSPGetInitialGuessKnoll KSP_NORM_PRECONDITIONED KSPSTCGGetObjFcn
KSPGetNormType KSPNormType KSPSTCGSetRadius
KSPGetNullSpace KSP_NORM_UNPRECONDITIONED KSPUnwindPreconditioner
KSPGetOptionsPrefix KSPQCGGetQuadratic MatGetSchurComplement
Developer - Interfaces intended primarily for library developers, not for typical applications programmers
DMCopyDMKSP KSPGetTabLevel KSPSetPostSolve
DMGetDMKSP KSPGLTR KSPSetPreSolve
DMGetDMKSPWrite KSPInitializePackage KSPSetSupportedNorm
DMKSPCopy KSPInitialResidual KSPSetTabLevel
KSPChebyshevSetNewMatrix KSPMonitor KSPSetUp
KSPFinalizePackage KSPMonitorSAWsCreate KSPSolveTranspose
KSPGetFischerGuess KSPMonitorSAWsDestroy KSPSTCG
KSPGetPC KSPNASH MatSchurComplementSetKSP
KSPGetRhs KSPQCG PCFinalizePackage
KSPGetSolution KSPSetPC PCInitializePackage
No deprecated routines

Table of Contents