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

Table of Contents