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

Table of Contents