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

Table of Contents