petsc-3.10.5 2019-03-28
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 KSPGMRES KSPSetFromOptions
KSPAGMRES KSPGuess KSPSetInitialGuessNonzero
KSPBCGS KSPGuessCreate KSPSetOperators
KSPBCGSL KSPGuessSetFromOptions KSPSolve
KSPBICG KSPGuessType KSPTCQMR
KSPCG KSPIBCGS KSPTFQMR
KSPCGLS KSPLCD KSPType
KSPCGNE KSPLGMRES KSPView
KSPCGS KSPLSQR KSP_CONVERGED_ATOL
KSPCGType KSPMINRES KSP_CONVERGED_ITERATING
KSPCHEBYSHEV KSPMonitorSet KSP_CONVERGED_ITS
KSPCR KSPPGMRES KSP_CONVERGED_RTOL
KSPConvergedReason KSPPREONLY KSP_DIVERGED_BREAKDOWN
KSPCreate KSPRICHARDSON KSP_DIVERGED_BREAKDOWN_BICG
KSPDGMRES KSPReasonView KSP_DIVERGED_DTOL
KSPDestroy KSPReset KSP_DIVERGED_INDEFINITE_PC
KSPFBCGS KSPResetFromOptions KSP_DIVERGED_ITS
KSPFBCGSR KSPSYMMLQ KSP_DIVERGED_NONSYMMETRIC
KSPFCG KSPSetComputeInitialGuess KSP_DIVERGED_PCSETUP_FAILED
KSPFGMRES KSPSetComputeOperators
KSPGCR KSPSetComputeRHS
Intermediate - Setting options for algorithms and data structures
KSPBCGSLSetEll KSPGetMonitorContext KSPPIPEGCRGetUnrollW
KSPBCGSLSetPol KSPGetOperators KSPPIPEGCRSetMmax
KSPBCGSLSetUsePseudoinverse KSPGetOperatorsSet KSPPIPEGCRSetModifyPC
KSPBCGSLSetXRes KSPGetPCSide KSPPIPEGCRSetTruncationType
KSPCGSetType KSPGetResidualNorm KSPPIPEGCRSetUnrollW
KSPCGUseSingleReduction KSPGetTolerances KSPPIPELCG
KSPChebyshevEstEigGetKSP KSPGetTotalIterations KSPPythonSetType
KSPChebyshevEstEigSet KSPGetType KSPReasonViewFromOptions
KSPChebyshevEstEigSetUseNoisy KSPGuessFormGuess KSPRichardsonSetScale
KSPChebyshevSetEigenvalues KSPGuessGetType KSPRichardsonSetSelfScale
KSPConvergedDefault KSPGuessSetType KSPSetApplicationContext
KSPConvergedDefaultCreate KSPGuessSetUp KSPSetDM
KSPConvergedDefaultDestroy KSPGuessUpdate KSPSetDMActive
KSPConvergedDefaultSetUIRNorm KSPGuessView KSPSetDiagonalScale
KSPConvergedDefaultSetUMIRNorm KSPLSQRConvergedDefault KSPSetDiagonalScaleFix
KSPFCDTruncationType KSPLSQRGetNorms KSPSetErrorIfNotConverged
KSPFCGGetMmax KSPLSQRGetStandardErrorVec KSPSetPCSide
KSPFCGGetTruncationType KSPLSQRMonitorDefault KSPSetReusePreconditioner
KSPFCGSetMmax KSPLSQRSetComputeStandardErrorVec KSPSetSkipPCSetFromOptions
KSPFCGSetTruncationType KSPLSQRSetExactMatNorm KSPSetTolerances
KSPFGMRESModifyPCKSP KSPLoad KSPSetType
KSPFGMRESModifyPCNoChange KSPMonitorCancel MatCreateLMVMBFGS
KSPFGMRESSetModifyPC KSPMonitorDefault MatCreateLMVMBadBrdn
KSPGCRSetModifyPC KSPMonitorLGResidualNormCreate MatCreateLMVMBrdn
KSPGMRESClassicalGramSchmidtOrthogonalization KSPMonitorLGTrueResidualNormCreate MatCreateLMVMDFP
KSPGMRESGetCGSRefinementType KSPMonitorRange MatCreateLMVMDiagBrdn
KSPGMRESGetOrthogonalization KSPMonitorSingularValue MatCreateLMVMSR1
KSPGMRESGetRestart KSPMonitorSolution MatCreateLMVMSymBadBrdn
KSPGMRESModifiedGramSchmidtOrthogonalization KSPMonitorTrueResidualMaxNorm MatCreateLMVMSymBrdn
KSPGMRESMonitorKrylov KSPMonitorTrueResidualNorm MatCreateSchurComplement
KSPGMRESSetCGSRefinementType KSPPIPEBCGS MatLMVMAllocate
KSPGMRESSetHapTol KSPPIPECG MatLMVMGetRejectCount
KSPGMRESSetOrthogonalization KSPPIPECGRR MatLMVMGetUpdateCount
KSPGMRESSetPreAllocateVectors KSPPIPECR MatLMVMIsAllocated
KSPGMRESSetRestart KSPPIPEFCG MatLMVMReset
KSPGROPPCG KSPPIPEFCGGetMmax MatLMVMResetShift
KSPGetApplicationContext KSPPIPEFCGGetTruncationType MatLMVMUpdate
KSPGetConvergedReason KSPPIPEFCGSetMmax MatSchurComplementAinvType
KSPGetDM KSPPIPEFCGSetTruncationType MatSchurComplementGetKSP
KSPGetDiagonalScale KSPPIPEFGMRES MatSchurComplementGetSubMatrices
KSPGetDiagonalScaleFix KSPPIPEFGMRESSetShift MatSchurComplementSetSubMatrices
KSPGetErrorIfNotConverged KSPPIPEGCR MatSchurComplementUpdateSubMatrices
KSPGetInitialGuessNonzero KSPPIPEGCRGetMmax MatSymBrdnSetDelta
KSPGetIterationNumber KSPPIPEGCRGetTruncationType
Advanced - Setting more advanced options and customization
DMGlobalToLocalSolve KSPGetComputeEigenvalues KSPSetOptionsPrefix
DMKSPGetComputeInitialGuess KSPGetComputeSingularValues KSPSetResidualHistory
DMKSPGetComputeOperators KSPGetConvergenceContext KSPSetUpOnBlocks
DMKSPGetComputeRHS KSPGetInitialGuessKnoll KSPSetUseFischerGuess
DMKSPSetComputeInitialGuess KSPGetNormType KSPTSIRM
DMKSPSetComputeOperators KSPGetOptionsPrefix KSPUnwindPreconditioner
DMKSPSetComputeRHS KSPGetResidualHistory KSP_GMRES_CGS_REFINE_IFNEEDED
KSPAppendOptionsPrefix KSPGuessFischerSetModel KSP_GMRES_CGS_REFINE_NEVER
KSPBuildResidual KSPMatRegisterAll KSP_NORM_NATURAL
KSPBuildSolution KSPMonitorDynamicTolerance KSP_NORM_NONE
KSPCGGLTRGetLambda KSPMonitorSAWs KSP_NORM_PRECONDITIONED
KSPCGGLTRGetMinEig KSPNormType KSP_NORM_UNPRECONDITIONED
KSPCGGetNormD KSPPIPEFCGGetNprealloc MatCreateSchurComplementPmat
KSPCGGetObjFcn KSPPIPEFCGSetNprealloc MatGetSchurComplement
KSPCGSetRadius KSPPIPEGCRGetNprealloc MatLMVMApplyJ0Fwd
KSPComputeEigenvalues KSPPIPEGCRSetNprealloc MatLMVMApplyJ0Inv
KSPComputeEigenvaluesExplicitly KSPQCGGetQuadratic MatLMVMClearJ0
KSPComputeExplicitOperator KSPQCGGetTrialStepNorm MatLMVMGetJ0
KSPComputeExtremeSingularValues KSPQCGSetTrustRegionRadius MatLMVMGetJ0KSP
KSPComputeRitz KSPRegister MatLMVMGetJ0PC
KSPConvergedSkip KSPRegisterAll MatLMVMSetJ0
KSPCreateVecs KSPSetCheckNormIteration MatLMVMSetJ0Diag
KSPFCGGetNprealloc KSPSetComputeEigenvalues MatLMVMSetJ0KSP
KSPFCGSetNprealloc KSPSetComputeRitz MatLMVMSetJ0PC
KSPFETIDP KSPSetComputeSingularValues MatLMVMSetJ0Scale
KSPFETIDPGetInnerBDDC KSPSetConvergenceTest MatSchurComplementComputeExplicitOperator
KSPFETIDPGetInnerKSP KSPSetGuess MatSchurComplementGetAinvType
KSPFETIDPSetInnerBDDC KSPSetInitialGuessKnoll MatSchurComplementGetPmat
KSPFETIDPSetPressureOperator KSPSetLagNorm MatSchurComplementSetAinvType
KSPGMRESCGSRefinementType KSPSetNormType
Developer - Interfaces intended primarily for library developers, not for typical applications programmers
DMCopyDMKSP KSPGetRhs KSPSetPostSolve
DMGetDMKSP KSPGetSolution KSPSetPreSolve
DMGetDMKSPWrite KSPGetTabLevel KSPSetSupportedNorm
DMKSPCopy KSPInitialResidual KSPSetTabLevel
DMProjectField KSPInitializePackage KSPSetUp
KSPCGGLTR KSPMonitor KSPSetWorkVecs
KSPCGNASH KSPMonitorSAWsCreate KSPSolveTranspose
KSPCGSTCG KSPMonitorSAWsDestroy MatSchurComplementSetKSP
KSPFinalizePackage KSPMonitorSetFromOptions PCFinalizePackage
KSPGetGuess KSPQCG PCInitializePackage
KSPGetPC KSPSetPC
No deprecated routines

Table of Contents