Thyra  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
List of all members
Thyra::ResponseOnlyModelEvaluatorBase< Scalar > Class Template Reference

This base class defines default function implementations appropritate for a response-only model evaluator (p) -> g(j), for j=0...Ng-1. More...

#include <Thyra_ResponseOnlyModelEvaluatorBase.hpp>

Inheritance diagram for Thyra::ResponseOnlyModelEvaluatorBase< Scalar >:
Inheritance graph
[legend]

Public functions overridden from ModelEvaulator.

RCP< const VectorSpaceBase
< Scalar > > 
get_x_space () const
 Throws exception. More...
 
RCP< const Teuchos::Array
< std::string > > 
get_p_names (int l) const
 Returns null. More...
 
Teuchos::ArrayView< const
std::string > 
get_g_names (int j) const
 Returns null. More...
 
RCP< const VectorSpaceBase
< Scalar > > 
get_f_space () const
 Throws exception. More...
 
ModelEvaluatorBase::InArgs
< Scalar > 
getNominalValues () const
 Returns this->createInArgs(). More...
 
ModelEvaluatorBase::InArgs
< Scalar > 
getLowerBounds () const
 Returns this->createInArgs(). More...
 
ModelEvaluatorBase::InArgs
< Scalar > 
getUpperBounds () const
 Returns this->createInArgs(). More...
 
RCP< LinearOpWithSolveBase
< Scalar > > 
create_W () const
 Thorws exception. More...
 
RCP< LinearOpBase< Scalar > > create_W_op () const
 Thorws exception. More...
 
RCP< PreconditionerBase< Scalar > > create_W_prec () const
 Thorws exception. More...
 
RCP< const
LinearOpWithSolveFactoryBase
< Scalar > > 
get_W_factory () const
 Thorws exception. More...
 
void reportFinalPoint (const ModelEvaluatorBase::InArgs< Scalar > &finalPoint, const bool wasSolved)
 Does nothing and ignores input. More...
 

Additional Inherited Members

- Public Types inherited from Thyra::ModelEvaluator< Scalar >
typedef Teuchos::ScalarTraits
< Scalar >::magnitudeType 
ScalarMag
 
- Public Types inherited from Thyra::ModelEvaluatorBase
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 }
 
- Public Member Functions inherited from Thyra::ModelEvaluatorDefaultBase< Scalar >
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
 
- Public Member Functions inherited from Thyra::ModelEvaluator< Scalar >
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...
 
- Public Member Functions inherited from Thyra::ModelEvaluatorBase
 ModelEvaluatorBase ()
 constructor More...
 
- Static Public Attributes inherited from Thyra::ModelEvaluatorBase
static const int NUM_E_IN_ARGS_MEMBERS =13
 
static const int NUM_E_OUT_ARGS_MEMBERS =7
 
- Protected Member Functions inherited from Thyra::ModelEvaluatorDefaultBase< Scalar >
 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...
 

Detailed Description

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.

Member Function Documentation

template<class Scalar >
RCP< const VectorSpaceBase< Scalar > > Thyra::ResponseOnlyModelEvaluatorBase< Scalar >::get_x_space ( ) const
virtual

Throws exception.

Implements Thyra::ModelEvaluator< Scalar >.

Definition at line 112 of file Thyra_ResponseOnlyModelEvaluatorBase.hpp.

template<class Scalar >
RCP< const Teuchos::Array< std::string > > Thyra::ResponseOnlyModelEvaluatorBase< Scalar >::get_p_names ( int  l) const
virtual

Returns null.

Implements Thyra::ModelEvaluator< Scalar >.

Definition at line 120 of file Thyra_ResponseOnlyModelEvaluatorBase.hpp.

template<class Scalar >
Teuchos::ArrayView< const std::string > Thyra::ResponseOnlyModelEvaluatorBase< Scalar >::get_g_names ( int  j) const
virtual

Returns null.

Implements Thyra::ModelEvaluator< Scalar >.

Definition at line 133 of file Thyra_ResponseOnlyModelEvaluatorBase.hpp.

template<class Scalar >
RCP< const VectorSpaceBase< Scalar > > Thyra::ResponseOnlyModelEvaluatorBase< Scalar >::get_f_space ( ) const
virtual

Throws exception.

Implements Thyra::ModelEvaluator< Scalar >.

Definition at line 145 of file Thyra_ResponseOnlyModelEvaluatorBase.hpp.

template<class Scalar >
ModelEvaluatorBase::InArgs< Scalar > Thyra::ResponseOnlyModelEvaluatorBase< Scalar >::getNominalValues ( ) const
virtual

Returns this->createInArgs().

Implements Thyra::ModelEvaluator< Scalar >.

Definition at line 153 of file Thyra_ResponseOnlyModelEvaluatorBase.hpp.

template<class Scalar >
ModelEvaluatorBase::InArgs< Scalar > Thyra::ResponseOnlyModelEvaluatorBase< Scalar >::getLowerBounds ( ) const
virtual

Returns this->createInArgs().

Implements Thyra::ModelEvaluator< Scalar >.

Definition at line 159 of file Thyra_ResponseOnlyModelEvaluatorBase.hpp.

template<class Scalar >
ModelEvaluatorBase::InArgs< Scalar > Thyra::ResponseOnlyModelEvaluatorBase< Scalar >::getUpperBounds ( ) const
virtual

Returns this->createInArgs().

Implements Thyra::ModelEvaluator< Scalar >.

Definition at line 165 of file Thyra_ResponseOnlyModelEvaluatorBase.hpp.

template<class Scalar >
RCP< LinearOpWithSolveBase< Scalar > > Thyra::ResponseOnlyModelEvaluatorBase< Scalar >::create_W ( ) const
virtual

Thorws exception.

Reimplemented from Thyra::ModelEvaluatorDefaultBase< Scalar >.

Definition at line 171 of file Thyra_ResponseOnlyModelEvaluatorBase.hpp.

template<class Scalar >
RCP< LinearOpBase< Scalar > > Thyra::ResponseOnlyModelEvaluatorBase< Scalar >::create_W_op ( ) const
virtual

Thorws exception.

Implements Thyra::ModelEvaluator< Scalar >.

Definition at line 185 of file Thyra_ResponseOnlyModelEvaluatorBase.hpp.

template<class Scalar >
RCP< PreconditionerBase< Scalar > > Thyra::ResponseOnlyModelEvaluatorBase< Scalar >::create_W_prec ( ) const
virtual

Thorws exception.

Implements Thyra::ModelEvaluator< Scalar >.

Definition at line 199 of file Thyra_ResponseOnlyModelEvaluatorBase.hpp.

template<class Scalar >
RCP< const LinearOpWithSolveFactoryBase< Scalar > > Thyra::ResponseOnlyModelEvaluatorBase< Scalar >::get_W_factory ( ) const
virtual

Thorws exception.

Implements Thyra::ModelEvaluator< Scalar >.

Definition at line 213 of file Thyra_ResponseOnlyModelEvaluatorBase.hpp.

template<class Scalar >
void Thyra::ResponseOnlyModelEvaluatorBase< Scalar >::reportFinalPoint ( const ModelEvaluatorBase::InArgs< Scalar > &  finalPoint,
const bool  wasSolved 
)
virtual

Does nothing and ignores input.

Implements Thyra::ModelEvaluator< Scalar >.

Definition at line 226 of file Thyra_ResponseOnlyModelEvaluatorBase.hpp.


The documentation for this class was generated from the following file: