This base class defines default function implementations appropritate for a response-only model evaluator (p) -> g(j), for j=0...Ng-1.  
 More...
|  | 
| typedef Teuchos::ScalarTraits < Scalar >::magnitudeType
 | ScalarMag | 
|  | 
| enum | EInArgsMembers { IN_ARG_x_dot_dot, 
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_W_x_dot_dot_coeff, 
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 | EOutArgs_hess_vec_prod_f_xx { OUT_ARG_hess_vec_prod_f_xx
 } | 
|  | 
| enum | EOutArgs_hess_vec_prod_f_xp { OUT_ARG_hess_vec_prod_f_xp
 } | 
|  | 
| enum | EOutArgs_hess_vec_prod_f_px { OUT_ARG_hess_vec_prod_f_px
 } | 
|  | 
| enum | EOutArgs_hess_vec_prod_f_pp { OUT_ARG_hess_vec_prod_f_pp
 } | 
|  | 
| enum | EOutArgs_hess_vec_prod_g_xx { OUT_ARG_hess_vec_prod_g_xx
 } | 
|  | 
| enum | EOutArgs_hess_vec_prod_g_xp { OUT_ARG_hess_vec_prod_g_xp
 } | 
|  | 
| enum | EOutArgs_hess_vec_prod_g_px { OUT_ARG_hess_vec_prod_g_px
 } | 
|  | 
| enum | EOutArgs_hess_vec_prod_g_pp { OUT_ARG_hess_vec_prod_g_pp
 } | 
|  | 
| enum | EOutArgs_hess_f_xx { OUT_ARG_hess_f_xx
 } | 
|  | 
| enum | EOutArgs_hess_f_xp { OUT_ARG_hess_f_xp
 } | 
|  | 
| enum | EOutArgs_hess_f_pp { OUT_ARG_hess_f_pp
 } | 
|  | 
| enum | EOutArgs_hess_g_xx { OUT_ARG_hess_g_xx
 } | 
|  | 
| enum | EOutArgs_hess_g_xp { OUT_ARG_hess_g_xp
 } | 
|  | 
| enum | EOutArgs_hess_g_pp { OUT_ARG_hess_g_pp
 } | 
|  | 
| enum | EOutArgs_H_xx { OUT_ARG_H_xx
 } | 
|  | 
| enum | EOutArgs_H_xp { OUT_ARG_H_xp
 } | 
|  | 
| enum | EOutArgs_H_pp { OUT_ARG_H_pp
 } | 
|  | 
| 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
 } | 
|  | 
| int | Np () const | 
|  | 
| int | Ng () const | 
|  | 
| RCP< LinearOpBase< Scalar > > | create_DfDp_op (int l) const | 
|  | 
| RCP< LinearOpBase< Scalar > > | create_DgDx_dot_op (int j) const | 
|  | 
| RCP< LinearOpBase< Scalar > > | create_DgDx_op (int j) const | 
|  | 
| RCP< LinearOpBase< Scalar > > | create_DgDp_op (int j, int l) const | 
|  | 
| ModelEvaluatorBase::OutArgs < Scalar >
 | createOutArgs () const | 
|  | 
| void | evalModel (const ModelEvaluatorBase::InArgs< Scalar > &inArgs, const ModelEvaluatorBase::OutArgs< Scalar > &outArgs) const | 
|  | 
| virtual RCP< const VectorSpaceBase< Scalar > >
 | get_f_multiplier_space () const | 
|  | 
| virtual RCP< const VectorSpaceBase< Scalar > >
 | get_g_multiplier_space (int j) const | 
|  | 
| virtual RCP< LinearOpBase < Scalar > >
 | create_hess_f_xx () const | 
|  | 
| virtual RCP< LinearOpBase < Scalar > >
 | create_hess_f_xp (int l) const | 
|  | 
| virtual RCP< LinearOpBase < Scalar > >
 | create_hess_f_pp (int l1, int l2) const | 
|  | 
| virtual RCP< LinearOpBase < Scalar > >
 | create_hess_g_xx (int j) const | 
|  | 
| virtual RCP< LinearOpBase < Scalar > >
 | create_hess_g_xp (int j, int l) const | 
|  | 
| virtual RCP< LinearOpBase < Scalar > >
 | create_hess_g_pp (int j, int l1, int l2) const | 
|  | 
| 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 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 ModelEvaluatorBase::InArgs
 < Scalar >
 | createInArgs () const =0 | 
|  | Create an empty input arguments object that can be set up and passed to evalModel().  More...
 | 
|  | 
|  | ModelEvaluatorBase () | 
|  | constructor  More... 
 | 
|  | 
| static const int | NUM_E_IN_ARGS_MEMBERS =13 | 
|  | 
| static const int | NUM_E_OUT_ARGS_MEMBERS =7 | 
|  | 
|  | ModelEvaluatorDefaultBase () | 
|  | 
| void | initializeDefaultBase () | 
|  | Function called by subclasses to fully initialize this object on any important change.  More... 
 | 
|  | 
| void | resetDefaultBase () | 
|  | Sets the the DefaultBase to an uninitialized state, forcing lazy initialization when needed.  More... 
 | 
|  | 
| 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) | 
|  | 
template<class Scalar>
class 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. 
The minimum that a subclass must to is to define implementations for get_p_space(), get_g_space(), createInArgs(), createOutArgsImpl, and evalModelImpl(). 
Definition at line 64 of file Thyra_ResponseOnlyModelEvaluatorBase.hpp.