petsc-3.4.5 2014-06-29

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 KSPGMRESSetOrthogonalization KSPMonitorLGTrueResidualNormDestroy
KSPBCGSLSetPol KSPGMRESSetPreAllocateVectors KSPMonitorRange
KSPBCGSLSetUsePseudoinverse KSPGMRESSetRestart KSPMonitorSingularValue
KSPBCGSLSetXRes KSPGetApplicationContext KSPMonitorSolution
KSPCGSetType KSPGetConvergedReason KSPMonitorTrueResidualMaxNorm
KSPCGUseSingleReduction KSPGetDM KSPMonitorTrueResidualNorm
KSPChebyshevEstEigSetRandom KSPGetDiagonalScale KSPPythonSetType
KSPChebyshevSetEigenvalues KSPGetDiagonalScaleFix KSPRichardsonSetScale
KSPChebyshevSetEstimateEigenvalues KSPGetErrorIfNotConverged KSPRichardsonSetSelfScale
KSPDefaultConverged KSPGetInitialGuessNonzero KSPSPECEST
KSPDefaultConvergedCreate KSPGetIterationNumber KSPSetApplicationContext
KSPDefaultConvergedDestroy KSPGetMonitorContext KSPSetDM
KSPDefaultConvergedSetUIRNorm KSPGetOperators KSPSetDMActive
KSPDefaultConvergedSetUMIRNorm KSPGetOperatorsSet KSPSetDiagonalScale
KSPFGMRESModifyPCKSP KSPGetPCSide KSPSetDiagonalScaleFix
KSPFGMRESModifyPCNoChange KSPGetResidualNorm KSPSetErrorIfNotConverged
KSPFGMRESSetModifyPC KSPGetTolerances KSPSetPCSide
KSPGCRSetModifyPC KSPGetType KSPSetTolerances
KSPGMRESClassicalGramSchmidtOrthogonalization KSPLSQRDefaultConverged KSPSetType
KSPGMRESGetCGSRefinementType KSPLSQRMonitorDefault MatCreateSchurComplement
KSPGMRESGetOrthogonalization KSPLoad MatSchurComplementGetKSP
KSPGMRESGetRestart KSPMonitorCancel MatSchurComplementGetSubmatrices
KSPGMRESModifiedGramSchmidtOrthogonalization KSPMonitorDefault MatSchurComplementSet
KSPGMRESMonitorKrylov KSPMonitorLGResidualNormCreate MatSchurComplementUpdate
KSPGMRESSetCGSRefinementType KSPMonitorLGResidualNormDestroy
KSPGMRESSetHapTol KSPMonitorLGTrueResidualNormCreate
Advanced - Setting more advanced options and customization
DMKSPGetComputeInitialGuess KSPGetConvergenceContext KSPSetCheckNormIteration
DMKSPGetComputeOperators KSPGetInitialGuessKnoll KSPSetComputeEigenvalues
DMKSPGetComputeRHS KSPGetNormType KSPSetComputeSingularValues
DMKSPSetComputeInitialGuess KSPGetNullSpace KSPSetConvergenceTest
DMKSPSetComputeOperators KSPGetOptionsPrefix KSPSetFischerGuess
DMKSPSetComputeRHS KSPGetResidualHistory KSPSetInitialGuessKnoll
KSPAppendOptionsPrefix KSPGetVecs KSPSetLagNorm
KSPBuildResidual KSPMatRegisterAll KSPSetNormType
KSPBuildSolution KSPMonitorAMS KSPSetNullSpace
KSPComputeEigenvalues KSPMonitorDynamicTolerance KSPSetOptionsPrefix
KSPComputeEigenvaluesExplicitly KSPNASHGetNormD KSPSetResidualHistory
KSPComputeExplicitOperator KSPNASHGetObjFcn KSPSetUpOnBlocks
KSPComputeExtremeSingularValues KSPNASHSetRadius KSPSetUseFischerGuess
KSPFischerGuessCreate KSPNormType KSPSkipConverged
KSPGLTRGetLambda KSPQCGGetQuadratic KSPUnwindPreconditioner
KSPGLTRGetMinEig KSPQCGGetTrialStepNorm KSP_GMRES_CGS_REFINE_IFNEEDED
KSPGLTRGetNormD KSPQCGSetTrustRegionRadius KSP_GMRES_CGS_REFINE_NEVER
KSPGLTRGetObjFcn KSPRegister KSP_NORM_NATURAL
KSPGLTRSetRadius KSPRegisterAll KSP_NORM_NONE
KSPGMRESCGSRefinementType KSPSTCGGetNormD KSP_NORM_PRECONDITIONED
KSPGetComputeEigenvalues KSPSTCGGetObjFcn KSP_NORM_UNPRECONDITIONED
KSPGetComputeSingularValues KSPSTCGSetRadius MatGetSchurComplement
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 KSPMonitorAMSCreate KSPSetUp
KSPGLTR KSPMonitorAMSDestroy KSPSolveTranspose
KSPGetFischerGuess KSPNASH MatSchurComplementSetKSP
KSPGetPC KSPQCG PCFinalizePackage
KSPGetRhs KSPSTCG PCInitializePackage
No deprecated routines
None: Not yet cataloged
KSPGROPPCG KSPPIPECG KSPPIPECR

Table of Contents