|
(Note that these are not member functions.)
|
template<class Scalar > |
RCP< ModelEvaluatorBase::InArgs< Scalar > > | clone (const ModelEvaluatorBase::InArgs< Scalar > &inArgs) |
| Create a clone of an InArgs object. More...
|
|
template<class Scalar > |
ModelEvaluatorBase::Derivative< Scalar > | derivativeGradient (const RCP< MultiVectorBase< Scalar > > &grad) |
|
template<class Scalar > |
ModelEvaluatorBase::DerivativeMultiVector< Scalar > | create_DfDp_mv (const ModelEvaluator< Scalar > &model, int l, ModelEvaluatorBase::EDerivativeMultiVectorOrientation orientation) |
|
template<class Scalar > |
ModelEvaluatorBase::DerivativeMultiVector< Scalar > | create_DgDx_dot_mv (const ModelEvaluator< Scalar > &model, int j, ModelEvaluatorBase::EDerivativeMultiVectorOrientation orientation) |
|
template<class Scalar > |
ModelEvaluatorBase::DerivativeMultiVector< Scalar > | create_DgDx_mv (const ModelEvaluator< Scalar > &model, int j, ModelEvaluatorBase::EDerivativeMultiVectorOrientation orientation) |
|
template<class Scalar > |
ModelEvaluatorBase::DerivativeMultiVector< Scalar > | create_DgDp_mv (const ModelEvaluator< Scalar > &model, int j, int l, ModelEvaluatorBase::EDerivativeMultiVectorOrientation orientation) |
|
template<class Scalar > |
ModelEvaluatorBase::DerivativeMultiVector< Scalar > | get_dmv (const ModelEvaluatorBase::Derivative< Scalar > &deriv, const std::string &derivName) |
|
template<class Scalar > |
RCP< MultiVectorBase< Scalar > > | get_mv (const ModelEvaluatorBase::Derivative< Scalar > &deriv, const std::string &derivName, ModelEvaluatorBase::EDerivativeMultiVectorOrientation orientation) |
|
template<class Scalar > |
void | assertDerivSpaces (const std::string &modelEvalDescription, const ModelEvaluatorBase::Derivative< Scalar > &deriv, const std::string &deriv_name, const VectorSpaceBase< Scalar > &fnc_space, const std::string &fnc_space_name, const VectorSpaceBase< Scalar > &var_space, const std::string &var_space_name) |
| Assert that that Thyra objects imbedded in a Derivative object matches its function and variable spaces. More...
|
|
template<class Scalar > |
void | assertInArgsOutArgsSetup (const std::string &modelEvalDescription, const ModelEvaluatorBase::InArgs< Scalar > &inArgs, const ModelEvaluatorBase::OutArgs< Scalar > &outArgs) |
| Assert that an InArgs and OutArgs object are setup consistently. More...
|
|
template<class Scalar > |
void | assertInArgsEvalObjects (const ModelEvaluator< Scalar > &model, const ModelEvaluatorBase::InArgs< Scalar > &inArgs) |
| Assert that the objects in an InArgs object match a given model. More...
|
|
template<class Scalar > |
void | assertOutArgsEvalObjects (const ModelEvaluator< Scalar > &model, const ModelEvaluatorBase::OutArgs< Scalar > &outArgs, const ModelEvaluatorBase::InArgs< Scalar > *inArgs=0) |
| Assert that the objects in an OutArgs object match a given model. More...
|
|
std::string | toString (ModelEvaluatorBase::EInArgsMembers) |
|
std::string | toString (ModelEvaluatorBase::EOutArgsMembers) |
|
std::string | toString (ModelEvaluatorBase::EDerivativeMultiVectorOrientation orientation) |
|
ModelEvaluatorBase::EDerivativeMultiVectorOrientation | getOtherDerivativeMultiVectorOrientation (ModelEvaluatorBase::EDerivativeMultiVectorOrientation orientation) |
|
|
typedef Teuchos::ScalarTraits< Scalar >::magnitudeType | ScalarMag |
|
enum | EInArgsMembers {
IN_ARG_x_dot,
IN_ARG_x,
IN_ARG_x_dot_poly,
IN_ARG_x_poly,
IN_ARG_x_dot_mp,
IN_ARG_x_mp,
IN_ARG_t,
IN_ARG_alpha,
IN_ARG_beta,
IN_ARG_step_size,
IN_ARG_stage_number
} |
|
enum | EInArgs_p_mp { IN_ARG_p_mp
} |
|
enum | EEvalType { , EVAL_TYPE_APPROX_DERIV,
EVAL_TYPE_VERY_APPROX_DERIV
} |
| The type of an evaluation. More...
|
|
enum | EDerivativeMultiVectorOrientation { DERIV_MV_JACOBIAN_FORM,
DERIV_MV_GRADIENT_FORM,
DERIV_MV_BY_COL = DERIV_MV_JACOBIAN_FORM,
DERIV_TRANS_MV_BY_ROW = DERIV_MV_GRADIENT_FORM
} |
|
enum | EDerivativeLinearOp { DERIV_LINEAR_OP
} |
|
enum | EDerivativeLinearity { DERIV_LINEARITY_UNKNOWN,
DERIV_LINEARITY_CONST,
DERIV_LINEARITY_NONCONST
} |
|
enum | ERankStatus { DERIV_RANK_UNKNOWN,
DERIV_RANK_FULL,
DERIV_RANK_DEFICIENT
} |
|
enum | EOutArgsMembers {
OUT_ARG_f,
OUT_ARG_W,
OUT_ARG_f_mp,
OUT_ARG_W_mp,
OUT_ARG_W_op,
OUT_ARG_W_prec,
OUT_ARG_f_poly
} |
|
enum | EOutArgsDfDp { OUT_ARG_DfDp
} |
|
enum | EOutArgsDgDx_dot { OUT_ARG_DgDx_dot
} |
|
enum | EOutArgsDgDx { OUT_ARG_DgDx
} |
|
enum | EOutArgsDgDp { OUT_ARG_DgDp
} |
|
enum | EOutArgsDfDp_mp { OUT_ARG_DfDp_mp
} |
|
enum | EOutArgs_g_mp { OUT_ARG_g_mp
} |
|
enum | EOutArgsDgDx_dot_mp { OUT_ARG_DgDx_dot_mp
} |
|
enum | EOutArgsDgDx_mp { OUT_ARG_DgDx_mp
} |
|
enum | EOutArgsDgDp_mp { OUT_ARG_DgDp_mp
} |
|
virtual RCP< const VectorSpaceBase< Scalar > > | get_x_space () const =0 |
| Return the vector space for the state variables x <: RE^n_x . More...
|
|
virtual RCP< const VectorSpaceBase< Scalar > > | get_f_space () const =0 |
| Return the vector space for the state function f(...) <: RE^n_x . More...
|
|
virtual RCP< const VectorSpaceBase< Scalar > > | get_p_space (int l) const =0 |
| Return the vector space for the auxiliary parameters p(l) <: RE^n_p_l . More...
|
|
virtual RCP< const Teuchos::Array< std::string > > | get_p_names (int l) const =0 |
| Get the names of the parameters associated with parameter subvector l if available. More...
|
|
virtual RCP< const VectorSpaceBase< Scalar > > | get_g_space (int j) const =0 |
| Return the vector space for the auxiliary response functions g(j) <: RE^n_g_j . More...
|
|
virtual Teuchos::ArrayView< const std::string > | get_g_names (int j) const =0 |
| Get the names of the response functions associated with subvector j if available. More...
|
|
virtual ModelEvaluatorBase::InArgs< Scalar > | getNominalValues () const =0 |
| Return the set of nominal values or initial guesses for the supported the input arguments. More...
|
|
virtual ModelEvaluatorBase::InArgs< Scalar > | getLowerBounds () const =0 |
| Return the set of lower bounds for the input arguments. More...
|
|
virtual ModelEvaluatorBase::InArgs< Scalar > | getUpperBounds () const =0 |
| Return the set of upper bounds for the input arguments. More...
|
|
virtual RCP< LinearOpBase< Scalar > > | create_W_op () const =0 |
| If supported, create a LinearOpBase object for W to be evaluated. More...
|
|
virtual RCP< PreconditionerBase< Scalar > > | create_W_prec () const =0 |
| If supported, create a PreconditionerBase object for W_prec to be evaluated. More...
|
|
virtual RCP< const LinearOpWithSolveFactoryBase< Scalar > > | get_W_factory () const =0 |
| If supported, return a LinearOpWithSolveFactoryBase object that can be used to initialize a LOWSB object for W given a LOB object for W_op . More...
|
|
virtual ModelEvaluatorBase::InArgs< Scalar > | createInArgs () const =0 |
| Create an empty input arguments object that can be set up and passed to evalModel() . More...
|
|
virtual void | reportFinalPoint (const ModelEvaluatorBase::InArgs< Scalar > &finalPoint, const bool wasSolved)=0 |
| Report the final point and whether the problem was considered solved or not. More...
|
|
| ModelEvaluatorBase () |
| constructor More...
|
|
static const int | NUM_E_IN_ARGS_MEMBERS =11 |
|
static const int | NUM_E_OUT_ARGS_MEMBERS =7 |
|
template<class Scalar>
class Thyra::ModelEvaluatorDefaultBase< Scalar >
Default base class for concrete model evaluators.
The primary purposes of this base class are to:
-
Provide default implementations for other forms of derivatives in ModelEvaluatorBase::Derivative
. For example, if a multi-vector form of a derivative (i.e. my column DhDy
or by row DhDy^T
) is provided then the other form will be provided assuming the range space has in-core vectors. Also, if any multi-vector form of a general derivative is provided, a LinearOpBase
version is automatically supported.
-
Provide a default implementation for computing the LOWSB
from W
given the LOB
-only form W_op
given a LOWSFB
object W_factory
supplied by the subclass. If the subclass wants to take this over, then it should override create_W()
.
-
Assert (in debug mode) that the underlying model has been set up correctly.
ToDo: Finish Documentation!
Definition at line 188 of file Thyra_ModelEvaluatorDefaultBase.hpp.