Thyra
Version of the Day
|
▶NTeuchos | |
CPolynomialTraits< Thyra::VectorBase< Scalar > > | Specilization of Teuchos::PolynomialTraits for Thyra vectors |
▶NThyra | |
▶NDirectionalFiniteDiffCalculatorTypes | |
CSelectedDerivatives | Simple utility class used to select finite difference derivatives for OutArgs object |
▶NExceptions | |
CIncompatibleVectorSpaces | Thrown if vector spaces are incompatible |
COpNotSupported | |
CUnInitialized | Thrown if any member functions are called before initialize() has been called |
CAddedLinearOpBase | Interface class for implicitly added linear operators |
CBlockedLinearOpBase | Base interface for linear operators that can be accessed as sub-blocks |
CBlockedLinearOpWithSolveBase | Base interface for linear operators with a solve that can be accessed as sub-blocks |
CCatastrophicSolveFailure | Exception type thrown on an catastrophic solve failure |
CConstDetachedMultiVectorView | Create an explicit non-mutable (const) view of a MultiVectorBase object |
CConstDetachedSpmdVectorView | Create an explicit detached non-mutable (const) view of all of the local elements on this process of an VectorBase object |
CConstDetachedVectorView | Create an explicit non-mutable (const) view of a VectorBase object |
CDampenedNewtonNonlinearSolver | Simple dampended Newton solver using a Armijo line search :-) |
CDefaultAddedLinearOp | Concrete composite LinearOpBase subclass that creates an implicitly added linear operator out of one or more constituent LinearOpBase objects |
CDefaultAdjointLinearOpWithSolve | Default concreate decorator subclass for a transpose/adjoint LinearOpWithSolveBase object |
CDefaultBlockedLinearOp | Concrete composite LinearOpBase subclass that creates single linear operator object out of a set of constituent LinearOpBase blocks |
CDefaultBlockedTriangularLinearOpWithSolve | Concrete composite LinearOpWithSolveBase subclass that creates single upper or lower block triangular LOWSB object out of a set of LOWSB objects along the diagonal with LOB objects off diagonal |
CDefaultBlockedTriangularLinearOpWithSolveFactory | Implicit subclass that takes a blocked triangular LOWB object and turns it into a LOWSB object |
CDefaultClusteredSpmdProductVector | Concrete implementation of a clustered Spmd-based product vector |
CDefaultClusteredSpmdProductVectorSpace | |
CDefaultColumnwiseMultiVector | Default subclass for MultiVectorBase implemented using columns of separate abstract vectors |
CDefaultDiagonalLinearOp | Default concrete LinearOpBase subclass for diagonal linear operators |
CDefaultDiagonalLinearOpWithSolve | Concrete LinearOpWithSolveBase subclass for diagonal linear operators |
CDefaultEvaluationLoggerModelEvaluator | This class wraps any ModelEvaluator object and logs the evaluation of various functions |
CDefaultFinalPointCaptureModelEvaluator | This class wraps any ModelEvaluator object and allows the client to capture the final point that is returned by a client |
CDefaultFiniteDifferenceModelEvaluator | This class wraps any ModelEvaluator object and computes certain derivatives using finite differences |
CDefaultIdentityLinearOp | Represents a identity linear operator M = I |
CDefaultInverseLinearOp | Concrete LinearOpBase subclass that creates an implicit LinearOpBase object using the inverse action of a LinearOpWithSolveBase object |
CDefaultInverseModelEvaluator | This class wraps any ModelEvaluator object and adds a simple, but fairly general, inverse response function |
CDefaultLinearOpSource | Default implementation of a LinearOpSourceBase that just accepts and gives up a single linear operator object |
CDefaultLumpedParameterModelEvaluator | Decorator class that wraps any ModelEvaluator object and lumps parameters together using a linear basis matrix |
CDefaultModelEvaluatorWithSolveFactory | This class wraps any ModelEvaluator object and uses a compatible LinearOpWithSolveFactory object to create a LinearOpWithSolveBase version of W |
CDefaultMultiPeriodModelEvaluator | Composite subclass that takes a single ModelEvaluator object and represents it as a single aggregate multi-period ModelEvalator object |
CDefaultMultipliedLinearOp | Concrete composite LinearOpBase subclass that creates an implicitly multiplied linear operator out of one or more constituent LinearOpBase objects |
CDefaultMultiVectorLinearOpWithSolve | Implicit concrete LinearOpWithSolveBase subclass that takes a flattended out multi-vector and performs a multi-RHS solve with it |
CDefaultMultiVectorProductVector | Concrete implementation of a product vector which is really composed out of the columns of a multi-vector |
CDefaultMultiVectorProductVectorSpace | Standard concrete implementation of a product vector space that creates product vectors fromed implicitly from the columns of a multi-vector |
CDefaultNominalBoundsOverrideModelEvaluator | This class wraps any ModelEvaluator object and allows the client to overide the state contained in the nominal values and the upper and lower bounds |
CDefaultNonlinearSolverBuilder | Concrete subclass of Thyra::NonlinearSolverBuilderBase for creating NonlinearSolverBase objects and PreconditionerFactoryBase object on demand given configured factory objects |
CDefaultPreconditioner | Default implementation of a PreconditionerBase that just accepts precreated preconditioner linear operators |
CDefaultProductMultiVector | Concrete implementation of a product multi-vector |
CDefaultProductVector | Concrete implementation of a product vector |
CDefaultProductVectorSpace | |
CDefaultScaledAdjointLinearOp | Concrete decorator LinearOpBase subclass that wraps a LinearOpBase object and adds on an extra scaling factor and/or a transpose enum |
CDefaultSerialDenseLinearOpWithSolve | Simple concreate subclass of LinearOpWithSolveBase for serial dense matrices implemented using LAPACK |
CDefaultSerialDenseLinearOpWithSolveFactory | Concreate LinearOpWithSolveFactoryBase subclass that creates DefaultSerialDenseLinearOpWithSolve objects that use LAPACK |
CDefaultSerialVectorSpaceConverter | Concrete subclass for a converter subclass for converting serial multi-vectors and vectors |
CDefaultSpmdMultiVector | Efficient concrete implementation subclass for SPMD multi-vectors |
CDefaultSpmdMultiVectorFileIO | Concrete implementation of MultiVectorFileIO that reads and writes SPMD-based (multi)vectors to and from files |
CDefaultSpmdVector | Efficient concrete implementation subclass for SPMD vectors |
CDefaultSpmdVectorSpace | Concrete implementation of an SPMD vector space subclass which creates DefaultSpmdVector and DefaultSpmdMultiVector objects |
CDefaultSpmdVectorSpaceFactory | Concrete implementation of a vector-space factory for a locally-replicated distributed DefaultSpmdVectorSpace objects |
CDefaultStateEliminationModelEvaluator | This class wraps any ModelEvaluator object along with a NonlinearSolverBase object and eliminates the steady-state equations f(x,...)=0 |
CDefaultZeroLinearOp | Represents a zero linear operator M = 0 |
CDelayedLinearOpWithSolve | Delayed linear solver construction LinearOpWithSolveBase decorator class |
CDelayedLinearOpWithSolveFactory | General delayed construction LinearOpWithSolveFactoryBase subclass |
CDetachedMultiVectorView | Create an explicit mutable (non-const) view of a MultiVectorBase object |
CDetachedSpmdVectorView | Create an explicit detached mutable (non-const) view of all of the local elements on this process of an VectorBase object |
CDetachedVectorView | Create an explicit mutable (non-const) view of a VectorBase object |
CDiagonalEpetraLinearOpWithSolveFactory | Create a DefaultDiagonalLinearOpWithSolve out of a diagonal Epetra_RowMatrix object |
CDiagonalLinearOpBase | Interface class for for diagonal linear operators |
CDiagonalQuadraticResponseOnlyModelEvaluator | Simple parallel response-only ModelEvaluator |
CDiagonalScalarProd | Concrete implementation of a scalar product using a diagonal vector |
CDirectionalFiniteDiffCalculator | Utility calss for computing directional finite differences of a model |
CDummyTestModelEvaluator | Test helper ModelEvaluator |
CEpetraExtAddTransformer | Transformer subclass for adding Epetra/Thyra operators using EpetraExt::MatrixMatrix |
CEpetraExtDiagScaledMatProdTransformer | Transformer subclass for diagonally scaling and multiplying Epetra/Thyra operators |
CEpetraExtDiagScalingTransformer | Transformer subclass for diagonally scaling a Epetra/Thyra operator |
CEpetraLinearOp | Concrete LinearOpBase adapter subclass for Epetra_Operator object |
CEpetraLinearOpBase | Abstract base class for all LinearOpBase objects that can return an Epetra_Operator view of themselves and details about how to apply the view |
CEpetraModelEvaluator | Concrete Adapter subclass that takes an EpetraExt::ModelEvaluator object and wraps it as a Thyra::ModelEvaluator object |
CEpetraOperatorViewExtractorBase | Strategy interface for extracting an Epetra_Operator view out of a Thyra::LinearOpBase<double> object |
CEpetraOperatorViewExtractorStd | Standard strategy subclass for extracting an Epetra_Operator view out of a Thyra::LinearOpBase<double> object by dynamic casting to the EpetraLinearOpBase interface |
CEpetraOperatorWrapper | Implements the Epetra_Operator interface with a Thyra LinearOperator |
CEuclideanScalarProd | Concrete implementation of a scalar product for a Euclidean vector space (i.e. using the dot product) |
CIdentityLinearOpBase | Interface class for identity linear operators |
CInverseLinearOpBase | Base interface for <ttLinearOpBase objects that are implemented in terms of the solve function on a LinearOpWithSolveBase object |
CLinearNonlinearSolver | Concrete nonlinear solver for linear equations |
CLinearOpBase | Base class for all linear operators |
CLinearOpChanger | Silly abstract strategy interface for changing Thyra::LinearOpBase objects |
CLinearOpDefaultBase | Node subclass that provides a good default implementation for the describe() function |
CLinearOpScalarProd | Concrete implementation of a scalar product using a symmetric positive-definite linear operator |
CLinearOpSourceBase | Base interface for objects that can return a linear operator |
CLinearOpTester | Testing class for LinearOpBase |
CLinearOpTransformerBase | Base interface for transforming a LinearOpBase object |
CLinearOpWithSolveBase | Base class for all linear operators that can support a high-level solve operation |
CLinearOpWithSolveFactoryBase | Factory interface for creating LinearOpWithSolveBase objects from compatible LinearOpBase objects |
CLinearOpWithSolveTester | Testing class for LinearOpWithSolveBase |
CLinearSolverBuilderBase | Abstract interface for an object that can create LinearOpWithSolveFactoryBase objects on demand |
CListedMultiVectorRandomizer | MultiVectorRandomizerBase subclass that returns a revolving list of preset MultiVectorBase objects |
CModelEvaluator | Pure abstract base interface for evaluating a stateless "model" that can be mapped into a number of different types of problems |
▶CModelEvaluatorBase | Base subclass for ModelEvaluator that defines some basic types |
CDerivative | Simple aggregate class that stores a derivative object as a general linear operator or as a multi-vector |
CDerivativeMultiVector | Simple aggregate class for a derivative object represented as a column-wise multi-vector or its transpose as a row-wise multi-vector |
CDerivativeProperties | Simple public strict containing properties of a derivative object |
CDerivativeSupport | Determines the forms of a general derivative that are supported |
CEvaluation | Type to embed evaluation accuracy with an RCP-managed object |
CInArgs | Concrete aggregate class for all output arguments computable by a ModelEvaluator subclass object |
CInArgsSetup | Protected subclass of InArgs that only ModelEvaluator subclasses can access to set up the selection of supported input arguments |
CMPDerivative | Simple aggregate class that stores a derivative object as a general linear operator or as a multi-vector |
CMPDerivativeMultiVector | Simple aggregate class for a derivative object represented as a column-wise multi-vector or its transpose as a row-wise multi-vector |
COutArgs | Concrete aggregate class for all output arguments computable by a ModelEvaluator subclass object |
COutArgsSetup | Protected subclass of OutArgs that only ModelEvaluator subclasses can access to set up the selection of supported input arguments |
CModelEvaluatorDefaultBase | Default base class for concrete model evaluators |
CModelEvaluatorDelegatorBase | This is a base class that delegetes almost all function to a wrapped model evaluator object |
CMultipliedLinearOpBase | Interface class for implicitly multiplied linear operators |
CMultiVectorAdapterBase | Node subclass for MultiVectorBase subclasses that allows the insertion of an application defined scalar product |
CMultiVectorAllocator | Allocator class to be used with Teuchos::AbstractFactoryStd to create MultiVectorBase objects of a given size |
CMultiVectorBase | Interface for a collection of column vectors called a multi-vector |
CMultiVectorDefaultBase | Node subclass that uses a default MultiVectorBase implementation to provide default implementations for as many other functions in MultiVectorBase interface the as is reasonable |
CMultiVectorFileIOBase | Abstract strategy interface for reading and writing (multi)vector objects to and from files |
CMultiVectorRandomizerBase | Base interface for a strategy object for randomizing a multi-vector |
CMultiVectorStdOpsTester | Testing class that tests all of the standard vector operations defined in ??? using an arbitrary vector space |
CMultiVectorTester | Unit testing class for a MultiVectorBase object |
CNonlinearSolverBase | Base class for all nonlinear equation solvers |
CNullLinearOpChanger | No-op changer |
CParameterDrivenMultiVectorInput | Concrete utility class that an ANA can use for reading in a (multi)vector as directed by a parameter sublist |
CPhysicallyBlockedLinearOpBase | Base interface for physically blocked linear operators |
CPhysicallyBlockedLinearOpWithSolveBase | Base interface for linear operators with a solve that are composed out of individual LOB and LOWSB objects |
CPreconditionerBase | Simple interface class to access a precreated preconditioner as one or more linear operators objects and information on how they are meant to be applied |
CPreconditionerFactoryBase | Factory interface for creating preconditioner objects from LinearOpBase objects |
CProductMultiVectorBase | Base interface for product multi-vectors |
CProductVectorBase | Base interface for product vectors |
CProductVectorSpaceBase | |
CReductionFunctional | A general reduction functional to be used in specialized solve convergence criteria |
CResponseOnlyModelEvaluatorBase | This base class defines default function implementations appropritate for a response-only model evaluator (p) -> g(j) , for j=0...Ng-1 |
CRowStatLinearOpBase | Interface for exxtracting row statistics as a VectorBase from a supporting LinearOpBase object |
CScalarProdBase | Abstract interface for scalar products |
CScalarProdVectorSpaceBase | Forward decl |
CScaledAdjointLinearOpBase | Base class for LinearOpBase decorator subclasses that wrap a LinearOpBase object and adds on an extra scaling factor and/or a new transpose enum |
CScaledLinearOpBase | Applies left or right sclaing to the linear operator |
CScaledModelEvaluator | This class decorates a ModelEvaluator and returns scaled residual and Jacobian values |
CSerialVectorSpaceConverterBase | Node base class for converting serial multi-vectors (and vectors) from one scalar type to another |
CSimple2DModelEvaluator | Simple 2d simulation only ModelEvaluator for f(x) = 0 |
CSolveCriteria | Simple struct that defines the requested solution criteria for a solve |
CSolveMeasureType | Solve tolerance type |
CSolveStatus | Simple struct for the return status from a solve |
CSpmdMultiVectorBase | Base interface class for SPMD multi-vectors |
CSpmdMultiVectorDefaultBase | Base node implementation class for SPMD multi-vectors |
CSpmdMultiVectorSerializer | Concrete utility class for reading and writing SPMD-based MultiVectorBase objects to and from standard streams |
CSpmdVectorBase | Base class for SPMD vectors that can provide views of contiguous elements in a process |
CSpmdVectorDefaultBase | Base class for SPMD vectors that can provide views of contiguous elements in a process |
CSpmdVectorSpaceBase | Base abstract VectorSpaceBase class for all SPMD-based vector spaces |
CSpmdVectorSpaceDefaultBase | Base VectorSpaceBase class for all SPMD vector spaces with contiguous local-to-global indexing |
CStateFuncModelEvaluatorBase | This base class defines default function implementations appropritate for a set of nonlinear state functions of the form x -> f(x) |
CTestResultsPrinter | Control printing of test results |
CTpetraLinearOp | Concrete Thyra::LinearOpBase subclass for Tpetra::Operator |
CTpetraMultiVector | Concrete implementation of Thyra::MultiVector in terms of Tpetra::MultiVector |
CTpetraOperatorVectorExtraction | Traits class that enables the extraction of Tpetra operator/vector objects wrapped in Thyra operator/vector objects |
CTpetraVector | Concrete Thyra::SpmdVectorBase using Tpetra::Vector |
CTpetraVectorSpace | Concrete implementation of an SPMD vector space for Tpetra |
CUniversalMultiVectorRandomizer | Univeral MultiVectorRandomizerBase subclass that is compatible with all MultiVectorBase objects |
CVectorBase | Abstract interface for finite-dimensional dense vectors |
CVectorDefaultBase | Convenient node subclass for concrete VectorBase subclasses that relies on a default MultiVectorBase implementation |
CVectorSpaceBase | Abstract interface for objects that represent a space for vectors |
CVectorSpaceConverterBase | Base interface for a factory that converts vector space types and vectors and multi-vectors from one scalar type to another |
CVectorSpaceDefaultBase | Node VectorSpaceBase subclass that provides default implementations for many functions using a default multi-vectors implementation |
CVectorSpaceFactoryBase | Abstract interface for objects that can create vector spaces of a specified dimension |
CVectorSpaceTester | Testing class for VectorSpace and the VectorBase and MultiVectorBase objects that it creates |
CVectorStdOpsTester | Testing class that tests all of the standard vector operations defined in ??? using an arbitrary vector space |
CVectorTester | Unit testing class for a VectorBase object |
CZeroLinearOpBase | Interface class for zero linear operators |
CExampleTridiagSerialLinearOp | Simple example subclass for serial tridiagonal matrices |
CExampleTridiagSpmdLinearOp | Simple example subclass for Spmd tridiagonal matrices |