petsc-3.3-p7 2013-05-11

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_BICG KSPMonitorSet
KSPBCGSL KSP_DIVERGED_BREAKDOWN KSPPGMRES
KSPBICG KSP_DIVERGED_DTOL KSPPREONLY
KSPCG KSP_DIVERGED_INDEFINITE_PC KSPReset
KSPCGNE KSP_DIVERGED_ITS KSPRICHARDSON
KSPCGS KSP_DIVERGED_NONSYMMETRIC KSPSetComputeOperators
KSPCGType KSPFBCGS KSPSetComputeRHS
KSPCHEBYSHEV KSPFGMRES KSPSetFromOptions
KSP_CONVERGED_ATOL KSPGCR KSPSetInitialGuessNonzero
KSP_CONVERGED_ITERATING KSPGMRES KSPSetOperators
KSP_CONVERGED_ITS KSP KSPSolve
KSPConvergedReason KSPIBCGS KSPSYMMLQ
KSP_CONVERGED_RTOL KSPIFBCGS KSPTCQMR
KSPCreate KSPLCD KSPTFQMR
KSPCR KSPLGMRES KSPType
KSPDestroy KSPLSQR KSPView
KSPDGMRES KSPMINRES
Intermediate - Setting options for algorithms and data structures
KSPBCGSLSetEll KSPGetOperators KSPMonitorLGTrueResidualNormCreate
KSPBCGSLSetPol KSPGetOperatorsSet KSPMonitorLGTrueResidualNormDestroy
KSPBCGSLSetXRes KSPGetPCSide KSPMonitorRange
KSPCGSetType KSPGetResidualNorm KSPMonitorSingularValue
KSPCGUseSingleReduction KSPGetTolerances KSPMonitorSolution
KSPChebyshevSetEigenvalues KSPGetType KSPMonitorTrueResidualNorm
KSPChebyshevSetEstimateEigenvalues KSPGMRESClassicalGramSchmidtOrthogonalization KSPPythonSetType
KSPDefaultConvergedCreate KSPGMRESGetCGSRefinementType KSPRichardsonSetScale
KSPDefaultConvergedDestroy KSPGMRESGetOrthogonalization KSPRichardsonSetSelfScale
KSPDefaultConverged KSPGMRESGetRestart KSPSetApplicationContext
KSPDefaultConvergedSetUIRNorm KSPGMRESModifiedGramSchmidtOrthogonalization KSPSetDiagonalScaleFix
KSPDefaultConvergedSetUMIRNorm KSPGMRESMonitorKrylov KSPSetDiagonalScale
KSPFGMRESModifyPCKSP KSPGMRESSetCGSRefinementType KSPSetDMActive
KSPFGMRESModifyPCNoChange KSPGMRESSetHapTol KSPSetDM
KSPFGMRESSetModifyPC KSPGMRESSetOrthogonalization KSPSetErrorIfNotConverged
KSPGCRSetModifyPC KSPGMRESSetPreAllocateVectors KSPSetPCSide
KSPGetApplicationContext KSPGMRESSetRestart KSPSetTolerances
KSPGetConvergedReason KSPLSQRDefaultConverged KSPSetType
KSPGetDiagonalScaleFix KSPLSQRMonitorDefault KSPSPECEST
KSPGetDiagonalScale KSPMonitorCancel MatCreateSchurComplement
KSPGetDM KSPMonitorDefault MatSchurComplementGetKSP
KSPGetErrorIfNotConverged KSPMonitorLGCreate MatSchurComplementGetSubmatrices
KSPGetInitialGuessNonzero KSPMonitorLGDestroy MatSchurComplementUpdate
KSPGetIterationNumber KSPMonitorLGRangeCreate
KSPGetMonitorContext KSPMonitorLGRangeDestroy
Advanced - Setting more advanced options and customization
DMKSPGetComputeOperators KSPGLTRGetMinEig KSPRegister
DMKSPGetComputeRHS KSPGLTRGetNormD KSPSetCheckNormIteration
DMKSPSetComputeOperators KSPGLTRGetObjFcn KSPSetComputeEigenvalues
DMKSPSetComputeRHS KSPGLTRSetRadius KSPSetComputeSingularValues
KSPAppendOptionsPrefix KSP_GMRES_CGS_REFINE_IFNEEDED KSPSetConvergenceTest
KSPBuildResidual KSPGMRESCGSRefinementType KSPSetFischerGuess
KSPBuildSolution KSP_GMRES_CGS_REFINE_NEVER KSPSetInitialGuessKnoll
KSPComputeEigenvaluesExplicitly KSPMonitorAMS KSPSetLagNorm
KSPComputeEigenvalues KSPNASHGetNormD KSPSetNormType
KSPComputeExplicitOperator KSPNASHGetObjFcn KSPSetNullSpace
KSPComputeExtremeSingularValues KSPNASHSetRadius KSPSetOptionsPrefix
KSPFischerGuessCreate KSP_NORM_NATURAL KSPSetResidualHistory
KSPGetComputeEigenvalues KSP_NORM_NONE KSPSetUpOnBlocks
KSPGetComputeSingularValues KSP_NORM_PRECONDITIONED KSPSetUseFischerGuess
KSPGetConvergenceContext KSPNormType KSPSkipConverged
KSPGetInitialGuessKnoll KSP_NORM_UNPRECONDITIONED KSPSTCGGetNormD
KSPGetNormType KSPQCGGetQuadratic KSPSTCGGetObjFcn
KSPGetNullSpace KSPQCGGetTrialStepNorm KSPSTCGSetRadius
KSPGetOptionsPrefix KSPQCGSetTrustRegionRadius KSPUnwindPreconditioner
KSPGetResidualHistory KSPRegisterAll MatGetSchurComplement
KSPGetVecs KSPRegisterDestroy
KSPGLTRGetLambda KSPRegisterDynamic
Developer - Interfaces intended primarily for library developers, not for typical applications programmers
DMKSPCopyContext KSPGetSolution KSPQCG
DMKSPGetContext KSPGLTR KSPSetPC
DMKSPGetContextWrite KSPInitializePackage KSPSetSupportedNorm
KSPChebyshevSetNewMatrix KSPInitialResidual KSPSetUp
KSPFinalizePackage KSPMonitorAMSCreate KSPSolveTranspose
KSPGetFischerGuess KSPMonitorAMSDestroy KSPSTCG
KSPGetPC KSPMonitor PCFinalizePackage
KSPGetRhs KSPNASH PCInitializePackage
No deprecated routines

Table of Contents