Teko  Version of the Day
Class List
Here are the classes, structs, unions and interfaces with brief descriptions:
[detail level 123]
 NTeko
 NEpetra
 CBlockedEpetraOperatorTear about a user specified Epetra_Operator (CrsMatrix) using a vector of vectors of GIDs for each block
 CDefaultMappingStrategyDefault mapping strategy for the basic EpetraOperatorWrapper
 CEpetraBlockPreconditionerA single Epetra wrapper for all the BlockPreconditioners
 CEpetraOperatorWrapperImplements 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
 CInverseMappingStrategyFlip a mapping strategy object around to give the "inverse" mapping strategy
 CMappingStrategyAbstract Mapping strategy for an EpetraOperatorWrapper
 CZeroedOperator
 NNS
 CALOperatorSparse matrix vector multiplication for augmented Lagrangian-based preconditioners
 CInvLSCStrategyA 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
 CLSCPrecondStatePreconditioner state for the LSC factory
 CLSCSIMPLECStrategyA 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
 CLSCStrategyStrategy for driving LSCPreconditionerFactory
 CModALPreconditionerFactoryModified augmented Lagrangian-based preconditioner for incompressible Navier-Stokes equations
 CModALPrecondStateClass for saving state variables for ModALPreconditionerFactory
 CPCDStrategyStrategy for computing implementation of the Pressure convection diffusion preconditioner
 CPresLaplaceLSCStrategyA 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
 CSIMPLEPreconditionerFactory
 CTimingsSIMPLEPreconditionerFactory
 NTpetraHelpers
 CBlockedTpetraOperatorTear about a user specified Tpetra::Operator<ST,LO,GO,NT> (CrsMatrix) using a vector of vectors of GIDs for each block
 CDefaultMappingStrategyDefault mapping strategy for the basic TpetraOperatorWrapper
 CInverseFactoryOperatorA single Epetra wrapper for all operators constructed from an inverse operator
 CInverseMappingStrategyFlip a mapping strategy object around to give the "inverse" mapping strategy
 CMappingStrategyAbstract Mapping strategy for an TpetraOperatorWrapper
 CTpetraBlockPreconditionerA single Epetra wrapper for all the BlockPreconditioners
 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
 CZeroedOperator
 CAddPreconditionerFactory
 CAddPrecondState
 CAutoClone
 CAutoCloneDummy
 CBlockImplicitLinearOpA virtual class that simplifies the construction of custom operators
 CBlockInvDiagonalStrategy
 CBlockLowerTriInverseOpThis linear operator computes the inverse of a lower triangular matrix
 CBlockPreconditionerFactoryAbstract class which block preconditioner factories in Teko should be based on
 CBlockPreconditionerStateAn implementation of a state object for block preconditioners
 CBlockReorderLeaf
 CBlockReorderManagerClass that describes how a flat blocked operator should be reordered
 CBlockUpperTriInverseOpThis linear operator computes the inverse of a upper triangular matrix
 CCloneable
 CCloneFactory
 CDiagnosticLinearOpThis linear operator prints diagnostics about operator application and creation times. It is useful for debugging problems and determining bottle necks
 CDiagnosticPreconditionerFactoryA class which builds a diagnostic operator to wrap the application of the inverse operator. Also times the construction of the inverse operator
 CDiagonallyScaledPreconditionerFactoryUsing 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
 CDiagonalPreconditionerFactoryPreconditioner factory for building explcit inverse of diagonal operators. This includes block operators
 CDiagonalPrecondState
 CGaussSeidelPreconditionerFactoryA factory that creates a block Gauss Seidel preconditioner. The user must specify the solvers (or preconditioners) to use to approximately invert the diagonal operators
 CIdentityPreconditionerFactory
 CImplicitLinearOpA virtual class that simplifies the construction of custom operators
 CInverseFactoryAbstract class for building an inverse operator
 CInvFactoryDiagStrategy
 CIterativePreconditionerFactoryA class which applies a preconditioner repeatedly. The inherit assumption is that the preconditioner corresponds to a residual correction
 CJacobiPreconditionerFactory
 CLU2x2DiagonalStrategyStrategy for computing $A_00^{-1}$ and $S^{-1}$ in the LU2x2PreconditionerFactory. Uses the diagonal of $A_00$ to build $S$
 CLU2x2InverseOpThis linear operator approximates the inverse of a block $ 2\times 2 $ operator using a block $ LDU $ decomposition
 CLU2x2PreconditionerFactoryConstruct a preconditioner using a LDU dcomposition of a block 2x2 matrix
 CLU2x2StrategyAbstract strategy for computing inv(F) and inv(S) in the LU2x2PreconditionerFactory
 CMultPreconditionerFactory
 CMultPrecondState
 CMultPrecsLinearOp
 CPreconditionerAn extension of the Thyra::DefaultPreconditioner class with some specializations useful for use within Teko
 CPreconditionerFactoryAbstract class which block preconditioner factories in Teko should be based on
 CPreconditionerLinearOpClass that wraps a PreconditionerBase object it makes it behave like a linear operator
 CPreconditionerStateAn implementation of a state object preconditioners
 CReorderedLinearOpThis class takes a blocked linear op and represents it in a flattened form
 CRequestCallback
 CRequestCallbackBase
 CRequestHandler
 CRequestHandlerContainer
 CStaticInvDiagStrategy
 CStaticLU2x2StrategyA simple strategy for use with LU2x2PreconditionerFactory, that offers static objects for inv(F) and inv(S)
 CStaticRequestCallback
 CStratimikosFactoryConcrete preconditioner factory subclass based on ML