Teko  Version of the Day
 All Classes Files Functions Variables Pages
Class List
Here are the classes, structs, unions and interfaces with brief descriptions:
[detail level 123]
\NTeko
 oNEpetra
 |oCBlockedEpetraOperatorTear about a user specified Epetra_Operator (CrsMatrix) using a vector of vectors of GIDs for each block
 |oCEpetraBlockPreconditionerA single Epetra wrapper for all the BlockPreconditioners
 |oCZeroedOperator
 |oCMappingStrategyAbstract Mapping strategy for an EpetraOperatorWrapper
 |oCInverseMappingStrategyFlip a mapping strategy object around to give the "inverse" mapping strategy
 |oCDefaultMappingStrategyDefault mapping strategy for the basic EpetraOperatorWrapper
 |oCEpetraOperatorWrapperImplements the Epetra_Operator interface with a Thyra LinearOperator. This enables the use of absrtact Thyra operators in AztecOO as preconditioners and operators, without being rendered into concrete Epetra matrices. This is my own modified version that was originally in Thyra
 |\CInverseFactoryOperatorA single Epetra wrapper for all operators constructed from an inverse operator
 oNmlutils
 |\CSmootherData
 oNNS
 |oCALOperatorSparse matrix vector multiplication for augmented Lagrangian-based preconditioners
 |oCInvLSCStrategyA strategy that takes a single inverse factory and uses that for all inverses. If no mass matrix is passed in the diagonal of the 1,1 block is used
 |oCLSCPrecondStatePreconditioner state for the LSC factory
 |oCLSCSIMPLECStrategyA strategy that takes a single inverse factory and uses that for all inverses. If no mass matrix is passed in the diagonal of the 1,1 block is used
 |oCLSCStrategyStrategy for driving LSCPreconditionerFactory
 |oCModALPrecondStateClass for saving state variables for ModALPreconditionerFactory
 |oCModALPreconditionerFactoryModified augmented Lagrangian-based preconditioner for incompressible Navier-Stokes equations
 |oCPCDStrategyStrategy for computing implementation of the Pressure convection diffusion preconditioner
 |oCPresLaplaceLSCStrategyA strategy that takes a single inverse factory and uses that for all inverses. If no mass matrix is passed in the diagonal of the 1,1 block is used
 |oCSIMPLEPreconditionerFactory
 |\CTimingsSIMPLEPreconditionerFactory
 oNTpetraHelpers
 |oCBlockedTpetraOperatorTear about a user specified Tpetra::Operator<ST,LO,GO,NT> (CrsMatrix) using a vector of vectors of GIDs for each block
 |oCTpetraBlockPreconditionerA single Epetra wrapper for all the BlockPreconditioners
 |oCZeroedOperator
 |oCInverseFactoryOperatorA single Epetra wrapper for all operators constructed from an inverse operator
 |oCMappingStrategyAbstract Mapping strategy for an TpetraOperatorWrapper
 |oCInverseMappingStrategyFlip a mapping strategy object around to give the "inverse" mapping strategy
 |oCDefaultMappingStrategyDefault mapping strategy for the basic TpetraOperatorWrapper
 |\CTpetraOperatorWrapperImplements the Epetra_Operator interface with a Thyra LinearOperator. This enables the use of absrtact Thyra operators in AztecOO as preconditioners and operators, without being rendered into concrete Epetra matrices. This is my own modified version that was originally in Thyra
 oCMLPreconditionerStateContains operator internals need for ML
 oCMLPreconditionerFactoryClass that constructs and returns an ML preconditioner object that is capable of doing block smoothing
 oCSmootherLinearOp
 oCAddPrecondState
 oCAddPreconditionerFactory
 oCBlockReorderManagerClass that describes how a flat blocked operator should be reordered
 oCBlockReorderLeaf
 oCBlockImplicitLinearOpA virtual class that simplifies the construction of custom operators
 oCBlockInvDiagonalStrategy
 oCStaticInvDiagStrategy
 oCInvFactoryDiagStrategy
 oCBlockLowerTriInverseOpThis linear operator computes the inverse of a lower triangular matrix
 oCBlockPreconditionerStateAn implementation of a state object for block preconditioners
 oCBlockPreconditionerFactoryAbstract class which block preconditioner factories in Teko should be based on
 oCBlockUpperTriInverseOpThis linear operator computes the inverse of a upper triangular matrix
 oCCloneable
 oCAutoCloneDummy
 oCAutoClone
 oCCloneFactory
 oCDiagnosticLinearOpThis linear operator prints diagnostics about operator application and creation times. It is useful for debugging problems and determining bottle necks
 oCDiagnosticPreconditionerFactoryA class which builds a diagnostic operator to wrap the application of the inverse operator. Also times the construction of the inverse operator
 oCDiagonallyScaledPreconditionerFactoryUsing an absolute row sum approximation of the matrix this factory creates an inverse using the explicity scaled matrix. The inverse of the scaling operation is automatically applied
 oCDiagonalPrecondState
 oCDiagonalPreconditionerFactoryPreconditioner factory for building explcit inverse of diagonal operators. This includes block operators
 oCGaussSeidelPreconditionerFactoryA factory that creates a block Gauss Seidel preconditioner. The user must specify the solvers (or preconditioners) to use to approximately invert the diagonal operators
 oCIdentityPreconditionerFactory
 oCImplicitLinearOpA virtual class that simplifies the construction of custom operators
 oCInverseFactoryAbstract class for building an inverse operator
 oCIterativePreconditionerFactoryA class which applies a preconditioner repeatedly. The inherit assumption is that the preconditioner corresponds to a residual correction
 oCJacobiPreconditionerFactory
 oCLU2x2DiagonalStrategyStrategy for computing $A_00^{-1}$ and $S^{-1}$ in the LU2x2PreconditionerFactory. Uses the diagonal of $A_00$ to build $S$
 oCLU2x2InverseOpThis linear operator approximates the inverse of a block $ 2\times 2 $ operator using a block $ LDU $ decomposition
 oCLU2x2PreconditionerFactoryConstruct a preconditioner using a LDU dcomposition of a block 2x2 matrix
 oCLU2x2StrategyAbstract strategy for computing inv(F) and inv(S) in the LU2x2PreconditionerFactory
 oCStaticLU2x2StrategyA simple strategy for use with LU2x2PreconditionerFactory, that offers static objects for inv(F) and inv(S)
 oCMultPrecondState
 oCMultPrecsLinearOp
 oCMultPreconditionerFactory
 oCPreconditionerAn extension of the Thyra::DefaultPreconditioner class with some specializations useful for use within Teko
 oCPreconditionerFactoryAbstract class which block preconditioner factories in Teko should be based on
 oCPreconditionerLinearOpClass that wraps a PreconditionerBase object it makes it behave like a linear operator
 oCPreconditionerStateAn implementation of a state object preconditioners
 oCReorderedLinearOpThis class takes a blocked linear op and represents it in a flattened form
 oCRequestCallbackBase
 oCRequestCallback
 oCRequestHandler
 oCRequestHandlerContainer
 oCStaticRequestCallback
 \CStratimikosFactoryConcrete preconditioner factory subclass based on ML