Thyra Version of the Day
Loading...
Searching...
No Matches
Class Hierarchy

Go to the graphical class hierarchy

This inheritance list is sorted roughly, but not completely, alphabetically:
[detail level 12345678]
 CThyra::CatastrophicSolveFailureException type thrown on an catastrophic solve failure
 CThyra::ConstDetachedMultiVectorView< Scalar >Create an explicit non-mutable (const) view of a MultiVectorBase object
 CThyra::ConstDetachedSpmdVectorView< Scalar >Create an explicit detached non-mutable (const) view of all of the local elements on this process of an VectorBase object
 CThyra::ConstDetachedVectorView< Scalar >Create an explicit non-mutable (const) view of a VectorBase object
 CThyra::DefaultNonlinearSolverBuilderConcrete subclass of Thyra::NonlinearSolverBuilderBase for creating NonlinearSolverBase objects and PreconditionerFactoryBase object on demand given configured factory objects
 CThyra::ModelEvaluatorBase::Derivative< Scalar >Simple aggregate class that stores a derivative object as a general linear operator or as a multi-vector
 CThyra::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
 CThyra::ModelEvaluatorBase::DerivativePropertiesSimple public strict containing properties of a derivative object
 CThyra::ModelEvaluatorBase::DerivativeSupportDetermines the forms of a general derivative that are supported
 CThyra::DetachedMultiVectorView< Scalar >Create an explicit mutable (non-const) view of a MultiVectorBase object
 CThyra::DetachedSpmdVectorView< Scalar >Create an explicit detached mutable (non-const) view of all of the local elements on this process of an VectorBase object
 CThyra::DetachedVectorView< Scalar >Create an explicit mutable (non-const) view of a VectorBase object
 CEpetra_Operator [external]
 CThyra::EpetraOperatorWrapperImplements the Epetra_Operator interface with a Thyra LinearOperator
 CThyra::Exceptions::IncompatibleVectorSpacesThrown if vector spaces are incompatible
 CTeuchos::LabeledObject [external]
 CTeuchos::Describable [external]
 CThyra::LinearOpChanger< Scalar >Silly abstract strategy interface for changing Thyra::LinearOpBase objects
 CThyra::NullLinearOpChanger< Scalar >No-op changer
 CThyra::LinearOpTester< Scalar >Testing class for LinearOpBase
 CThyra::ModelEvaluatorBase::MPDerivativeSimple aggregate class that stores a derivative object as a general linear operator or as a multi-vector
 CThyra::ModelEvaluatorBase::MPDerivativeMultiVectorSimple aggregate class for a derivative object represented as a column-wise multi-vector or its transpose as a row-wise multi-vector
 CThyra::MultiVectorAllocator< Scalar >Allocator class to be used with Teuchos::AbstractFactoryStd to create MultiVectorBase objects of a given size
 CThyra::MultiVectorRandomizerBase< Scalar >Base interface for a strategy object for randomizing a multi-vector
 CThyra::ListedMultiVectorRandomizer< Scalar >MultiVectorRandomizerBase subclass that returns a revolving list of preset MultiVectorBase objects
 CThyra::UniversalMultiVectorRandomizer< Scalar >Univeral MultiVectorRandomizerBase subclass that is compatible with all MultiVectorBase objects
 CThyra::MultiVectorStdOpsTester< Scalar >Testing class that tests all of the standard vector operations defined in ??? using an arbitrary vector space
 CThyra::Exceptions::OpNotSupported
 CTeuchos::ParameterListAcceptor [external]
 CThyra::LinearOpWithSolveFactoryBase< double >
 CTeuchos::ParameterListAcceptorDefaultBase [external]
 CThyra::DefaultInverseModelEvaluator< Scalar >This class wraps any ModelEvaluator object and adds a simple, but fairly general, inverse response function
 CThyra::DefaultLumpedParameterModelEvaluator< Scalar >Decorator class that wraps any ModelEvaluator object and lumps parameters together using a linear basis matrix
 CThyra::DirectionalFiniteDiffCalculator< Scalar >Utility class for computing directional finite differences of a model
 CThyra::EpetraModelEvaluatorConcrete Adapter subclass that takes an EpetraExt::ModelEvaluator object and wraps it as a Thyra::ModelEvaluator object
 CThyra::LinearOpWithSolveFactoryBase< Scalar >Factory interface for creating LinearOpWithSolveBase objects from compatible LinearOpBase objects
 CThyra::LinearSolverBuilderBase< Scalar >Abstract interface for an object that can create LinearOpWithSolveFactoryBase objects on demand
 CThyra::NonlinearSolverBase< Scalar >Base class for all nonlinear equation solvers
 CThyra::ParameterDrivenMultiVectorInput< Scalar >Concrete utility class that an ANA can use for reading in a (multi)vector as directed by a parameter sublist
 CThyra::PreconditionerFactoryBase< Scalar >Factory interface for creating preconditioner objects from LinearOpBase objects
 CTeuchos::PolynomialTraits< Thyra::VectorBase< Scalar > >Specilization of Teuchos::PolynomialTraits for Thyra vectors
 CTeuchos::RCP< class T > [external]
 CThyra::ModelEvaluatorBase::Evaluation< Thyra::VectorBase< double > >
 CThyra::ModelEvaluatorBase::Evaluation< Thyra::VectorBase< Scalar > >
 CThyra::ModelEvaluatorBase::Evaluation< ObjType >Type to embed evaluation accuracy with an RCP-managed object
 CThyra::DirectionalFiniteDiffCalculatorTypes::SelectedDerivativesSimple utility class used to select finite difference derivatives for OutArgs object
 CThyra::SolveCriteria< Scalar >Simple struct that defines the requested solution criteria for a solve
 CThyra::SolveMeasureTypeSolve tolerance type
 CThyra::SolveStatus< Scalar >Simple struct for the return status from a solve
 CThyra::SpmdMultiVectorSerializer< Scalar >Concrete utility class for reading and writing SPMD-based MultiVectorBase objects to and from standard streams
 CThyra::TestResultsPrinterControl printing of test results
 CThyra::TpetraOperatorVectorExtraction< Scalar, LocalOrdinal, GlobalOrdinal, Node >Traits class that enables the extraction of Tpetra operator/vector objects wrapped in Thyra operator/vector objects
 CThyra::Exceptions::UnInitializedThrown if any member functions are called before initialize() has been called
 CThyra::VectorSpaceConverterBase< ScalarFrom, ScalarTo >Base interface for a factory that converts vector space types and vectors and multi-vectors from one scalar type to another
 CThyra::SerialVectorSpaceConverterBase< ScalarFrom, ScalarTo >Node base class for converting serial multi-vectors (and vectors) from one scalar type to another
 CThyra::VectorSpaceTester< Scalar >Testing class for VectorSpace and the VectorBase and MultiVectorBase objects that it creates
 CThyra::VectorStdOpsTester< Scalar >Testing class that tests all of the standard vector operations defined in ??? using an arbitrary vector space
 CThyra::VectorTester< Scalar >Unit testing class for a VectorBase object
 CTeuchos::VerboseObjectBase [external]
 CTeuchos::VerboseObject< DirectionalFiniteDiffCalculator< Scalar > > [external]
 CTeuchos::VerboseObject< LinearOpTransformerBase< Scalar > > [external]
 CTeuchos::VerboseObject< LinearOpWithSolveBase< Scalar > > [external]
 CTeuchos::VerboseObject< LinearOpWithSolveFactoryBase< Scalar > > [external]
 CTeuchos::VerboseObject< ModelEvaluatorBase > [external]
 CTeuchos::VerboseObject< MultiVectorFileIOBase< Scalar > > [external]
 CTeuchos::VerboseObject< NonlinearSolverBase< Scalar > > [external]
 CTeuchos::VerboseObject< ParameterDrivenMultiVectorInput< Scalar > > [external]
 CTeuchos::VerboseObject< PreconditionerFactoryBase< Scalar > > [external]
 CTeuchos::VerboseObject< class ObjectType > [external]