Thyra::CatastrophicSolveFailure | Exception type thrown on an catastrophic solve failure |
Thyra::ConstDetachedMultiVectorView< Scalar > | Create an explicit non-mutable (const) view of a MultiVectorBase object |
Thyra::ConstDetachedSpmdVectorView< Scalar > | Create an explicit detached non-mutable (const) view of all of the local elements on this process of an VectorBase object |
Thyra::ConstDetachedVectorView< Scalar > | Create an explicit non-mutable (const) view of a VectorBase object |
Thyra::DefaultNonlinearSolverBuilder | Concrete subclass of Thyra::NonlinearSolverBuilderBase for creating NonlinearSolverBase objects and PreconditionerFactoryBase object on demand given configured factory objects |
Thyra::ModelEvaluatorBase::Derivative< Scalar > | Simple aggregate class that stores a derivative object as a general linear operator or as a multi-vector |
Thyra::ModelEvaluatorBase::DerivativeMultiVector< Scalar > | Simple aggregate class for a derivative object represented as a column-wise multi-vector or its transpose as a row-wise multi-vector |
Thyra::ModelEvaluatorBase::DerivativeProperties | Simple public strict containing properties of a derivative object |
Thyra::ModelEvaluatorBase::DerivativeSupport | Determines the forms of a general derivative that are supported |
Thyra::DetachedMultiVectorView< Scalar > | Create an explicit mutable (non-const) view of a MultiVectorBase object |
Thyra::DetachedSpmdVectorView< Scalar > | Create an explicit detached mutable (non-const) view of all of the local elements on this process of an VectorBase object |
Thyra::DetachedVectorView< Scalar > | Create an explicit mutable (non-const) view of a VectorBase object |
Epetra_Operator [external] | |
Thyra::EpetraOperatorWrapper | Implements the Epetra_Operator interface with a Thyra LinearOperator |
Thyra::Exceptions::IncompatibleVectorSpaces | Thrown if vector spaces are incompatible |
Teuchos::LabeledObject [external] | |
Teuchos::Describable [external] | |
Thyra::ModelEvaluatorBase::InArgs< double > | |
Thyra::LinearOpBase< double > | |
Thyra::RowStatLinearOpBase< double > | |
Thyra::EpetraLinearOp | Concrete LinearOpBase adapter subclass for Epetra_Operator object |
Thyra::ScaledLinearOpBase< double > | |
Thyra::EpetraLinearOp | Concrete LinearOpBase adapter subclass for Epetra_Operator object |
Thyra::EpetraLinearOp | Concrete LinearOpBase adapter subclass for Epetra_Operator object |
Thyra::LinearOpTransformerBase< double > | |
Thyra::EpetraExtAddTransformer | Transformer subclass for adding Epetra/Thyra operators using EpetraExt::MatrixMatrix |
Thyra::EpetraExtDiagScaledMatProdTransformer | Transformer subclass for diagonally scaling and multiplying Epetra/Thyra operators |
Thyra::EpetraExtDiagScalingTransformer | Transformer subclass for diagonally scaling a Epetra/Thyra operator |
Thyra::LinearOpWithSolveFactoryBase< double > | |
Thyra::DiagonalEpetraLinearOpWithSolveFactory | Create a DefaultDiagonalLinearOpWithSolve out of a diagonal Epetra_RowMatrix object |
Thyra::ModelEvaluatorBase::OutArgs< double > | |
Thyra::EpetraLinearOpBase | Abstract base class for all LinearOpBase objects that can return an Epetra_Operator view of themselves and details about how to apply the view |
Thyra::EpetraLinearOp | Concrete LinearOpBase adapter subclass for Epetra_Operator object |
Thyra::EpetraOperatorViewExtractorBase | Strategy interface for extracting an Epetra_Operator view out of a Thyra::LinearOpBase<double> object |
Thyra::EpetraOperatorViewExtractorStd | Standard strategy subclass for extracting an Epetra_Operator view out of a Thyra::LinearOpBase<double> object by dynamic casting to the EpetraLinearOpBase interface |
Thyra::LinearOpBase< Scalar > | Base class for all linear operators |
Thyra::AddedLinearOpBase< Scalar > | Interface class for implicitly added linear operators |
Thyra::DefaultAddedLinearOp< Scalar > | Concrete composite LinearOpBase subclass that creates an implicitly added linear operator out of one or more constituent LinearOpBase objects |
Thyra::BlockedLinearOpBase< Scalar > | Base interface for linear operators that can be accessed as sub-blocks |
Thyra::BlockedLinearOpWithSolveBase< Scalar > | Base interface for linear operators with a solve that can be accessed as sub-blocks |
Thyra::PhysicallyBlockedLinearOpWithSolveBase< Scalar > | Base interface for linear operators with a solve that are composed out of individual LOB and LOWSB objects |
Thyra::DefaultBlockedTriangularLinearOpWithSolve< Scalar > | 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 |
Thyra::PhysicallyBlockedLinearOpBase< Scalar > | Base interface for physically blocked linear operators |
Thyra::DefaultBlockedLinearOp< Scalar > | Concrete composite LinearOpBase subclass that creates single linear operator object out of a set of constituent LinearOpBase blocks |
Thyra::PhysicallyBlockedLinearOpWithSolveBase< Scalar > | Base interface for linear operators with a solve that are composed out of individual LOB and LOWSB objects |
Thyra::DiagonalLinearOpBase< Scalar > | Interface class for for diagonal linear operators |
Thyra::DefaultDiagonalLinearOp< Scalar > | Default concrete LinearOpBase subclass for diagonal linear operators |
Thyra::DefaultDiagonalLinearOpWithSolve< Scalar > | Concrete LinearOpWithSolveBase subclass for diagonal linear operators |
Thyra::IdentityLinearOpBase< Scalar > | Interface class for identity linear operators |
Thyra::DefaultIdentityLinearOp< Scalar > | Represents a identity linear operator M = I |
Thyra::InverseLinearOpBase< Scalar > | Base interface for <ttLinearOpBase objects that are implemented in terms of the solve function on a LinearOpWithSolveBase object |
Thyra::DefaultInverseLinearOp< Scalar > | Concrete LinearOpBase subclass that creates an implicit LinearOpBase object using the inverse action of a LinearOpWithSolveBase object |
Thyra::LinearOpDefaultBase< Scalar > | Node subclass that provides a good default implementation for the describe() function |
ExampleTridiagSerialLinearOp< Scalar > | Simple example subclass for serial tridiagonal matrices |
ExampleTridiagSpmdLinearOp< Scalar > | Simple example subclass for Spmd tridiagonal matrices |
Thyra::MultiVectorDefaultBase< Scalar > | Node subclass that uses a default MultiVectorBase implementation to provide default implementations for as many other functions in MultiVectorBase interface the as is reasonable |
Thyra::DefaultColumnwiseMultiVector< Scalar > | Default subclass for MultiVectorBase implemented using columns of separate abstract vectors |
Thyra::DefaultProductMultiVector< Scalar > | Concrete implementation of a product multi-vector |
Thyra::MultiVectorAdapterBase< Scalar > | Node subclass for MultiVectorBase subclasses that allows the insertion of an application defined scalar product |
Thyra::SpmdMultiVectorDefaultBase< Scalar > | Base node implementation class for SPMD multi-vectors |
Thyra::DefaultSpmdMultiVector< Scalar > | Efficient concrete implementation subclass for SPMD multi-vectors |
Thyra::TpetraMultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > | Concrete implementation of Thyra::MultiVector in terms of Tpetra::MultiVector |
Thyra::VectorDefaultBase< Scalar > | Convenient node subclass for concrete VectorBase subclasses that relies on a default MultiVectorBase implementation |
Thyra::DefaultClusteredSpmdProductVector< Scalar > | Concrete implementation of a clustered Spmd-based product vector |
Thyra::DefaultMultiVectorProductVector< Scalar > | Concrete implementation of a product vector which is really composed out of the columns of a multi-vector |
Thyra::DefaultProductVector< Scalar > | Concrete implementation of a product vector |
Thyra::SpmdVectorDefaultBase< Scalar > | Base class for SPMD vectors that can provide views of contiguous elements in a process |
Thyra::DefaultSpmdVector< Scalar > | Efficient concrete implementation subclass for SPMD vectors |
Thyra::TpetraVector< Scalar, LocalOrdinal, GlobalOrdinal, Node > | Concrete Thyra::SpmdVectorBase using Tpetra::Vector |
Thyra::TpetraLinearOp< Scalar, LocalOrdinal, GlobalOrdinal, Node > | Concrete Thyra::LinearOpBase subclass for Tpetra::Operator |
Thyra::LinearOpWithSolveBase< Scalar > | Base class for all linear operators that can support a high-level solve operation |
Thyra::BlockedLinearOpWithSolveBase< Scalar > | Base interface for linear operators with a solve that can be accessed as sub-blocks |
Thyra::DefaultAdjointLinearOpWithSolve< Scalar > | Default concreate decorator subclass for a transpose/adjoint LinearOpWithSolveBase object |
Thyra::DefaultDiagonalLinearOpWithSolve< Scalar > | Concrete LinearOpWithSolveBase subclass for diagonal linear operators |
Thyra::DefaultMultiVectorLinearOpWithSolve< Scalar > | Implicit concrete LinearOpWithSolveBase subclass that takes a flattended out multi-vector and performs a multi-RHS solve with it |
Thyra::DefaultSerialDenseLinearOpWithSolve< Scalar > | Simple concreate subclass of LinearOpWithSolveBase for serial dense matrices implemented using LAPACK |
Thyra::DelayedLinearOpWithSolve< Scalar > | Delayed linear solver construction LinearOpWithSolveBase decorator class |
Thyra::MultipliedLinearOpBase< Scalar > | Interface class for implicitly multiplied linear operators |
Thyra::DefaultMultipliedLinearOp< Scalar > | Concrete composite LinearOpBase subclass that creates an implicitly multiplied linear operator out of one or more constituent LinearOpBase objects |
Thyra::MultiVectorBase< Scalar > | Interface for a collection of column vectors called a multi-vector |
Thyra::MultiVectorDefaultBase< Scalar > | Node subclass that uses a default MultiVectorBase implementation to provide default implementations for as many other functions in MultiVectorBase interface the as is reasonable |
Thyra::ProductMultiVectorBase< Scalar > | Base interface for product multi-vectors |
Thyra::DefaultProductMultiVector< Scalar > | Concrete implementation of a product multi-vector |
Thyra::ProductVectorBase< Scalar > | Base interface for product vectors |
Thyra::DefaultClusteredSpmdProductVector< Scalar > | Concrete implementation of a clustered Spmd-based product vector |
Thyra::DefaultMultiVectorProductVector< Scalar > | Concrete implementation of a product vector which is really composed out of the columns of a multi-vector |
Thyra::DefaultProductVector< Scalar > | Concrete implementation of a product vector |
Thyra::SpmdMultiVectorBase< Scalar > | Base interface class for SPMD multi-vectors |
Thyra::SpmdMultiVectorDefaultBase< Scalar > | Base node implementation class for SPMD multi-vectors |
Thyra::SpmdVectorBase< Scalar > | Base class for SPMD vectors that can provide views of contiguous elements in a process |
Thyra::SpmdVectorDefaultBase< Scalar > | Base class for SPMD vectors that can provide views of contiguous elements in a process |
Thyra::VectorBase< Scalar > | Abstract interface for finite-dimensional dense vectors |
Thyra::ProductVectorBase< Scalar > | Base interface for product vectors |
Thyra::SpmdVectorBase< Scalar > | Base class for SPMD vectors that can provide views of contiguous elements in a process |
Thyra::VectorDefaultBase< Scalar > | Convenient node subclass for concrete VectorBase subclasses that relies on a default MultiVectorBase implementation |
Thyra::RowStatLinearOpBase< Scalar > | Interface for exxtracting row statistics as a VectorBase from a supporting LinearOpBase object |
Thyra::DefaultBlockedLinearOp< Scalar > | Concrete composite LinearOpBase subclass that creates single linear operator object out of a set of constituent LinearOpBase blocks |
Thyra::DefaultZeroLinearOp< Scalar > | Represents a zero linear operator M = 0 |
Thyra::MultiVectorBase< Scalar > | Interface for a collection of column vectors called a multi-vector |
Thyra::TpetraLinearOp< Scalar, LocalOrdinal, GlobalOrdinal, Node > | Concrete Thyra::LinearOpBase subclass for Tpetra::Operator |
Thyra::ScaledAdjointLinearOpBase< Scalar > | Base class for LinearOpBase decorator subclasses that wrap a LinearOpBase object and adds on an extra scaling factor and/or a new transpose enum |
Thyra::DefaultScaledAdjointLinearOp< Scalar > | Concrete decorator LinearOpBase subclass that wraps a LinearOpBase object and adds on an extra scaling factor and/or a transpose enum |
Thyra::ScaledLinearOpBase< Scalar > | Applies left or right sclaing to the linear operator |
Thyra::DefaultBlockedLinearOp< Scalar > | Concrete composite LinearOpBase subclass that creates single linear operator object out of a set of constituent LinearOpBase blocks |
Thyra::DefaultZeroLinearOp< Scalar > | Represents a zero linear operator M = 0 |
Thyra::MultiVectorBase< Scalar > | Interface for a collection of column vectors called a multi-vector |
Thyra::TpetraLinearOp< Scalar, LocalOrdinal, GlobalOrdinal, Node > | Concrete Thyra::LinearOpBase subclass for Tpetra::Operator |
Thyra::ZeroLinearOpBase< Scalar > | Interface class for zero linear operators |
Thyra::DefaultZeroLinearOp< Scalar > | Represents a zero linear operator M = 0 |
Thyra::LinearOpSourceBase< Scalar > | Base interface for objects that can return a linear operator |
Thyra::DefaultLinearOpSource< Scalar > | Default implementation of a LinearOpSourceBase that just accepts and gives up a single linear operator object |
Thyra::LinearOpTransformerBase< Scalar > | Base interface for transforming a LinearOpBase object |
Thyra::LinearOpWithSolveFactoryBase< Scalar > | Factory interface for creating LinearOpWithSolveBase objects from compatible LinearOpBase objects |
Thyra::DefaultBlockedTriangularLinearOpWithSolveFactory< Scalar > | Implicit subclass that takes a blocked triangular LOWB object and turns it into a LOWSB object |
Thyra::DefaultSerialDenseLinearOpWithSolveFactory< Scalar > | Concreate LinearOpWithSolveFactoryBase subclass that creates DefaultSerialDenseLinearOpWithSolve objects that use LAPACK |
Thyra::DelayedLinearOpWithSolveFactory< Scalar > | General delayed construction LinearOpWithSolveFactoryBase subclass |
Thyra::ModelEvaluatorBase | Base subclass for ModelEvaluator that defines some basic types |
Thyra::ModelEvaluator< double > | |
Thyra::ModelEvaluatorDefaultBase< double > | |
Thyra::EpetraModelEvaluator | Concrete Adapter subclass that takes an EpetraExt::ModelEvaluator object and wraps it as a Thyra::ModelEvaluator object |
Thyra::ModelEvaluator< Scalar > | Pure abstract base interface for evaluating a stateless "model" that can be mapped into a number of different types of problems |
Thyra::ModelEvaluatorDefaultBase< Scalar > | Default base class for concrete model evaluators |
Thyra::DefaultMultiPeriodModelEvaluator< Scalar > | Composite subclass that takes a single ModelEvaluator object and represents it as a single aggregate multi-period ModelEvalator object |
Thyra::DummyTestModelEvaluator< Scalar > | Test helper ModelEvaluator |
Thyra::ModelEvaluatorDelegatorBase< Scalar > | This is a base class that delegetes almost all function to a wrapped model evaluator object |
Thyra::DefaultEvaluationLoggerModelEvaluator< Scalar > | This class wraps any ModelEvaluator object and logs the evaluation of various functions |
Thyra::DefaultFinalPointCaptureModelEvaluator< Scalar > | This class wraps any ModelEvaluator object and allows the client to capture the final point that is returned by a client |
Thyra::DefaultFiniteDifferenceModelEvaluator< Scalar > | This class wraps any ModelEvaluator object and computes certain derivatives using finite differences |
Thyra::DefaultInverseModelEvaluator< Scalar > | This class wraps any ModelEvaluator object and adds a simple, but fairly general, inverse response function |
Thyra::DefaultLumpedParameterModelEvaluator< Scalar > | Decorator class that wraps any ModelEvaluator object and lumps parameters together using a linear basis matrix |
Thyra::DefaultModelEvaluatorWithSolveFactory< Scalar > | This class wraps any ModelEvaluator object and uses a compatible LinearOpWithSolveFactory object to create a LinearOpWithSolveBase version of W |
Thyra::DefaultNominalBoundsOverrideModelEvaluator< Scalar > | 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 |
Thyra::DefaultStateEliminationModelEvaluator< Scalar > | This class wraps any ModelEvaluator object along with a NonlinearSolverBase object and eliminates the steady-state equations f(x,...)=0 |
Thyra::ScaledModelEvaluator< Scalar > | This class decorates a ModelEvaluator and returns scaled residual and Jacobian values |
Thyra::TpetraExplicitAdjointModelEvaluator< Scalar, LocalOrdinal, GlobalOrdinal, Node > | A model evaluator decorator for computing an explicit adjoint |
Thyra::ResponseOnlyModelEvaluatorBase< Scalar > | This base class defines default function implementations appropritate for a response-only model evaluator (p) -> g(j) , for j=0...Ng-1 |
Thyra::DiagonalQuadraticResponseOnlyModelEvaluator< Scalar > | Simple parallel response-only ModelEvaluator |
Thyra::StateFuncModelEvaluatorBase< Scalar > | This base class defines default function implementations appropritate for a set of nonlinear state functions of the form x -> f(x) |
Thyra::Simple2DModelEvaluator< Scalar > | Simple 2d simulation only ModelEvaluator for f(x) = 0 |
Thyra::ModelEvaluatorBase::InArgs< Scalar > | Concrete aggregate class for all input arguments computable by a ModelEvaluator subclass object |
Thyra::ModelEvaluatorBase::InArgsSetup< Scalar > | Protected subclass of InArgs that only ModelEvaluator subclasses can access to set up the selection of supported input arguments |
Thyra::ModelEvaluatorBase::OutArgs< Scalar > | Concrete aggregate class for all output arguments computable by a ModelEvaluator subclass object |
Thyra::ModelEvaluatorBase::OutArgsSetup< Scalar > | Protected subclass of OutArgs that only ModelEvaluator subclasses can access to set up the selection of supported input arguments |
Thyra::MultiVectorTester< Scalar > | Unit testing class for a MultiVectorBase object |
Thyra::NonlinearSolverBase< Scalar > | Base class for all nonlinear equation solvers |
Thyra::DampenedNewtonNonlinearSolver< Scalar > | Simple dampended Newton solver using a Armijo line search :-) |
Thyra::LinearNonlinearSolver< Scalar > | Concrete nonlinear solver for linear equations |
Thyra::PreconditionerBase< Scalar > | 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 |
Thyra::DefaultPreconditioner< Scalar > | Default implementation of a PreconditionerBase that just accepts precreated preconditioner linear operators |
Thyra::PreconditionerFactoryBase< Scalar > | Factory interface for creating preconditioner objects from LinearOpBase objects |
Thyra::ReductionFunctional< Scalar > | A general reduction functional to be used in specialized solve convergence criteria |
Thyra::ScalarProdBase< Scalar > | Abstract interface for scalar products |
Thyra::DiagonalScalarProd< Scalar > | Concrete implementation of a scalar product using a diagonal vector |
Thyra::EuclideanScalarProd< Scalar > | Concrete implementation of a scalar product for a Euclidean vector space (i.e. using the dot product) |
Thyra::TpetraEuclideanScalarProd< Scalar, LocalOrdinal, GlobalOrdinal, Node > | Extends concrete implementation of a Euclidean scalar product for specifically Tpetra vectors/multivectors |
Thyra::LinearOpScalarProd< Scalar > | Concrete implementation of a scalar product using a symmetric positive-definite linear operator |
Thyra::VectorSpaceBase< Scalar > | Abstract interface for objects that represent a space for vectors |
Thyra::ProductVectorSpaceBase< Scalar > | |
Thyra::DefaultClusteredSpmdProductVectorSpace< Scalar > | |
Thyra::DefaultMultiVectorProductVectorSpace< Scalar > | Standard concrete implementation of a product vector space that creates product vectors fromed implicitly from the columns of a multi-vector |
Thyra::DefaultProductVectorSpace< Scalar > | |
Thyra::SpmdVectorSpaceBase< Scalar > | Base abstract VectorSpaceBase class for all SPMD-based vector spaces |
Thyra::SpmdVectorSpaceDefaultBase< Scalar > | Base VectorSpaceBase class for all SPMD vector spaces with contiguous local-to-global indexing |
Thyra::DefaultSpmdVectorSpace< Scalar > | Concrete implementation of an SPMD vector space subclass which creates DefaultSpmdVector and DefaultSpmdMultiVector objects |
Thyra::TpetraVectorSpace< Scalar, LocalOrdinal, GlobalOrdinal, Node > | Concrete implementation of an SPMD vector space for Tpetra |
Thyra::VectorSpaceDefaultBase< Scalar > | Node VectorSpaceBase subclass that provides default implementations for many functions using a default multi-vectors implementation |
Thyra::DefaultClusteredSpmdProductVectorSpace< Scalar > | |
Thyra::DefaultMultiVectorProductVectorSpace< Scalar > | Standard concrete implementation of a product vector space that creates product vectors fromed implicitly from the columns of a multi-vector |
Thyra::DefaultProductVectorSpace< Scalar > | |
Thyra::ScalarProdVectorSpaceBase< Scalar > | Forward decl |
Thyra::SpmdVectorSpaceDefaultBase< Scalar > | Base VectorSpaceBase class for all SPMD vector spaces with contiguous local-to-global indexing |
Thyra::VectorSpaceFactoryBase< Scalar > | Abstract interface for objects that can create vector spaces of a specified dimension |
Thyra::DefaultSpmdVectorSpaceFactory< Scalar > | Concrete implementation of a vector-space factory for a locally-replicated distributed DefaultSpmdVectorSpace objects |
Teuchos::Describable [external] | |
Teuchos::Describable [external] | |
Thyra::LinearOpChanger< Scalar > | Silly abstract strategy interface for changing Thyra::LinearOpBase objects |
Thyra::NullLinearOpChanger< Scalar > | No-op changer |
Thyra::LinearOpTester< Scalar > | Testing class for LinearOpBase |
Thyra::ModelEvaluatorBase::MPDerivative | Simple aggregate class that stores a derivative object as a general linear operator or as a multi-vector |
Thyra::ModelEvaluatorBase::MPDerivativeMultiVector | Simple aggregate class for a derivative object represented as a column-wise multi-vector or its transpose as a row-wise multi-vector |
Thyra::MultiVectorAllocator< Scalar > | Allocator class to be used with Teuchos::AbstractFactoryStd to create MultiVectorBase objects of a given size |
Thyra::MultiVectorRandomizerBase< Scalar > | Base interface for a strategy object for randomizing a multi-vector |
Thyra::ListedMultiVectorRandomizer< Scalar > | MultiVectorRandomizerBase subclass that returns a revolving list of preset MultiVectorBase objects |
Thyra::UniversalMultiVectorRandomizer< Scalar > | Univeral MultiVectorRandomizerBase subclass that is compatible with all MultiVectorBase objects |
Thyra::MultiVectorStdOpsTester< Scalar > | Testing class that tests all of the standard vector operations defined in ??? using an arbitrary vector space |
Thyra::Exceptions::OpNotSupported | |
Teuchos::ParameterListAcceptor [external] | |
Thyra::LinearOpWithSolveFactoryBase< double > | |
Teuchos::ParameterListAcceptorDefaultBase [external] | |
Thyra::DefaultSerialDenseLinearOpWithSolveFactory< Scalar > | Concreate LinearOpWithSolveFactoryBase subclass that creates DefaultSerialDenseLinearOpWithSolve objects that use LAPACK |
Thyra::LinearOpWithSolveTester< Scalar > | Testing class for LinearOpWithSolveBase |
Teuchos::ParameterListAcceptorDefaultBase [external] | |
Teuchos::ParameterListAcceptorDefaultBase [external] | |
Thyra::DefaultInverseModelEvaluator< Scalar > | This class wraps any ModelEvaluator object and adds a simple, but fairly general, inverse response function |
Thyra::DefaultLumpedParameterModelEvaluator< Scalar > | Decorator class that wraps any ModelEvaluator object and lumps parameters together using a linear basis matrix |
Thyra::DirectionalFiniteDiffCalculator< Scalar > | Utility class for computing directional finite differences of a model |
Thyra::EpetraModelEvaluator | Concrete Adapter subclass that takes an EpetraExt::ModelEvaluator object and wraps it as a Thyra::ModelEvaluator object |
Thyra::LinearOpWithSolveFactoryBase< Scalar > | Factory interface for creating LinearOpWithSolveBase objects from compatible LinearOpBase objects |
Thyra::LinearSolverBuilderBase< Scalar > | Abstract interface for an object that can create LinearOpWithSolveFactoryBase objects on demand |
Thyra::NonlinearSolverBase< Scalar > | Base class for all nonlinear equation solvers |
Thyra::ParameterDrivenMultiVectorInput< Scalar > | Concrete utility class that an ANA can use for reading in a (multi)vector as directed by a parameter sublist |
Thyra::PreconditionerFactoryBase< Scalar > | Factory interface for creating preconditioner objects from LinearOpBase objects |
Teuchos::PolynomialTraits< Thyra::VectorBase< Scalar > > | Specilization of Teuchos::PolynomialTraits for Thyra vectors |
Teuchos::RCP< T > [external] | |
Thyra::ModelEvaluatorBase::Evaluation< Thyra::VectorBase< double > > | |
Thyra::ModelEvaluatorBase::Evaluation< Thyra::VectorBase< Scalar > > | |
Thyra::ModelEvaluatorBase::Evaluation< ObjType > | Type to embed evaluation accuracy with an RCP-managed object |
Thyra::DirectionalFiniteDiffCalculatorTypes::SelectedDerivatives | Simple utility class used to select finite difference derivatives for OutArgs object |
Thyra::SolveCriteria< Scalar > | Simple struct that defines the requested solution criteria for a solve |
Thyra::SolveMeasureType | Solve tolerance type |
Thyra::SolveStatus< Scalar > | Simple struct for the return status from a solve |
Thyra::SpmdMultiVectorSerializer< Scalar > | Concrete utility class for reading and writing SPMD-based MultiVectorBase objects to and from standard streams |
Thyra::TestResultsPrinter | Control printing of test results |
Thyra::TpetraOperatorVectorExtraction< Scalar, LocalOrdinal, GlobalOrdinal, Node > | Traits class that enables the extraction of Tpetra operator/vector objects wrapped in Thyra operator/vector objects |
Thyra::Exceptions::UnInitialized | Thrown if any member functions are called before initialize() has been called |
Thyra::VectorSpaceConverterBase< ScalarFrom, ScalarTo > | Base interface for a factory that converts vector space types and vectors and multi-vectors from one scalar type to another |
Thyra::SerialVectorSpaceConverterBase< ScalarFrom, ScalarTo > | Node base class for converting serial multi-vectors (and vectors) from one scalar type to another |
Thyra::DefaultSerialVectorSpaceConverter< ScalarFrom, ScalarTo > | Concrete subclass for a converter subclass for converting serial multi-vectors and vectors |
Thyra::VectorSpaceTester< Scalar > | Testing class for VectorSpace and the VectorBase and MultiVectorBase objects that it creates |
Thyra::VectorStdOpsTester< Scalar > | Testing class that tests all of the standard vector operations defined in ??? using an arbitrary vector space |
Thyra::VectorTester< Scalar > | Unit testing class for a VectorBase object |
Teuchos::VerboseObjectBase [external] | |
Teuchos::VerboseObject< class > [external] | |
Thyra::LinearOpWithSolveFactoryBase< double > | |
Teuchos::VerboseObject< class > [external] | |
Teuchos::VerboseObject< class > [external] | |
Teuchos::VerboseObject< DirectionalFiniteDiffCalculator< Scalar > > [external] | |
Thyra::DirectionalFiniteDiffCalculator< Scalar > | Utility class for computing directional finite differences of a model |
Teuchos::VerboseObject< DirectionalFiniteDiffCalculator< Scalar > > [external] | |
Teuchos::VerboseObject< DirectionalFiniteDiffCalculator< Scalar > > [external] | |
Teuchos::VerboseObject< LinearOpTransformerBase< double > > [external] | |
Thyra::LinearOpTransformerBase< double > | |
Teuchos::VerboseObject< LinearOpTransformerBase< double > > [external] | |
Teuchos::VerboseObject< LinearOpTransformerBase< double > > [external] | |
Teuchos::VerboseObject< LinearOpTransformerBase< Scalar > > [external] | |
Thyra::LinearOpTransformerBase< Scalar > | Base interface for transforming a LinearOpBase object |
Teuchos::VerboseObject< LinearOpTransformerBase< Scalar > > [external] | |
Teuchos::VerboseObject< LinearOpTransformerBase< Scalar > > [external] | |
Teuchos::VerboseObject< LinearOpWithSolveBase< Scalar > > [external] | |
Thyra::LinearOpWithSolveBase< Scalar > | Base class for all linear operators that can support a high-level solve operation |
Teuchos::VerboseObject< LinearOpWithSolveBase< Scalar > > [external] | |
Teuchos::VerboseObject< LinearOpWithSolveBase< Scalar > > [external] | |
Teuchos::VerboseObject< LinearOpWithSolveFactoryBase< Scalar > > [external] | |
Thyra::LinearOpWithSolveFactoryBase< Scalar > | Factory interface for creating LinearOpWithSolveBase objects from compatible LinearOpBase objects |
Teuchos::VerboseObject< LinearOpWithSolveFactoryBase< Scalar > > [external] | |
Teuchos::VerboseObject< LinearOpWithSolveFactoryBase< Scalar > > [external] | |
Teuchos::VerboseObject< ModelEvaluatorBase > [external] | |
Thyra::ModelEvaluatorBase | Base subclass for ModelEvaluator that defines some basic types |
Teuchos::VerboseObject< ModelEvaluatorBase > [external] | |
Teuchos::VerboseObject< ModelEvaluatorBase > [external] | |
Teuchos::VerboseObject< MultiVectorFileIOBase< Scalar > > [external] | |
Thyra::MultiVectorFileIOBase< Scalar > | Abstract strategy interface for reading and writing (multi)vector objects to and from files |
Thyra::DefaultSpmdMultiVectorFileIO< Scalar > | Concrete implementation of MultiVectorFileIO that reads and writes SPMD-based (multi)vectors to and from files |
Teuchos::VerboseObject< MultiVectorFileIOBase< Scalar > > [external] | |
Teuchos::VerboseObject< MultiVectorFileIOBase< Scalar > > [external] | |
Teuchos::VerboseObject< NonlinearSolverBase< Scalar > > [external] | |
Thyra::NonlinearSolverBase< Scalar > | Base class for all nonlinear equation solvers |
Teuchos::VerboseObject< NonlinearSolverBase< Scalar > > [external] | |
Teuchos::VerboseObject< NonlinearSolverBase< Scalar > > [external] | |
Teuchos::VerboseObject< ParameterDrivenMultiVectorInput< Scalar > > [external] | |
Thyra::ParameterDrivenMultiVectorInput< Scalar > | Concrete utility class that an ANA can use for reading in a (multi)vector as directed by a parameter sublist |
Teuchos::VerboseObject< ParameterDrivenMultiVectorInput< Scalar > > [external] | |
Teuchos::VerboseObject< ParameterDrivenMultiVectorInput< Scalar > > [external] | |
Teuchos::VerboseObject< PreconditionerFactoryBase< Scalar > > [external] | |
Thyra::PreconditionerFactoryBase< Scalar > | Factory interface for creating preconditioner objects from LinearOpBase objects |
Teuchos::VerboseObject< PreconditionerFactoryBase< Scalar > > [external] | |
Teuchos::VerboseObject< PreconditionerFactoryBase< Scalar > > [external] | |