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

This base class defines default function implementations appropritate for a set of nonlinear state functions of the form x -> f(x). More...

#include <Thyra_StateFuncModelEvaluatorBase.hpp>

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

Public functions overridden from ModelEvaulator.

RCP< const VectorSpaceBase
< Scalar > > 
get_p_space (int l) const
 Throws exception. More...
 
RCP< const Teuchos::Array
< std::string > > 
get_p_names (int l) const
 Throws exception. More...
 
RCP< const VectorSpaceBase
< Scalar > > 
get_g_space (int j) const
 Throws exception. More...
 
Teuchos::ArrayView< const
std::string > 
get_g_names (int j) 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< LinearOpBase< Scalar > > create_W_op () const
 Throws exception. More...
 
RCP< PreconditionerBase< Scalar > > create_W_prec () const
 Returns null. More...
 
RCP< const
LinearOpWithSolveFactoryBase
< Scalar > > 
get_W_factory () const
 Returns null . More...
 
void reportFinalPoint (const ModelEvaluatorBase::InArgs< Scalar > &finalPoint, const bool wasSolved)
 Ignores input and does nothing. 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  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
 
RCP< LinearOpWithSolveBase
< Scalar > > 
create_W () 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
 
- Public Member Functions inherited from Thyra::ModelEvaluator< Scalar >
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
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::StateFuncModelEvaluatorBase< Scalar >

This base class defines default function implementations appropritate for a set of nonlinear state functions of the form x -> f(x).

The minimum that a subclass must do is to define implementations for get_x_space(), get_f_space(), createInArgs(), createOutArgsImpl, and evalModelImpl().

Definition at line 62 of file Thyra_StateFuncModelEvaluatorBase.hpp.

Member Function Documentation

template<class Scalar >
RCP< const VectorSpaceBase< Scalar > > Thyra::StateFuncModelEvaluatorBase< Scalar >::get_p_space ( int  l) const
virtual

Throws exception.

Implements Thyra::ModelEvaluator< Scalar >.

Definition at line 108 of file Thyra_StateFuncModelEvaluatorBase.hpp.

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

Throws exception.

Implements Thyra::ModelEvaluator< Scalar >.

Definition at line 121 of file Thyra_StateFuncModelEvaluatorBase.hpp.

template<class Scalar >
RCP< const VectorSpaceBase< Scalar > > Thyra::StateFuncModelEvaluatorBase< Scalar >::get_g_space ( int  j) const
virtual

Throws exception.

Implements Thyra::ModelEvaluator< Scalar >.

Definition at line 134 of file Thyra_StateFuncModelEvaluatorBase.hpp.

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

Throws exception.

Implements Thyra::ModelEvaluator< Scalar >.

Definition at line 148 of file Thyra_StateFuncModelEvaluatorBase.hpp.

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

Returns this->createInArgs().

Implements Thyra::ModelEvaluator< Scalar >.

Definition at line 167 of file Thyra_StateFuncModelEvaluatorBase.hpp.

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

Returns this->createInArgs().

Implements Thyra::ModelEvaluator< Scalar >.

Definition at line 173 of file Thyra_StateFuncModelEvaluatorBase.hpp.

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

Throws exception.

Implements Thyra::ModelEvaluator< Scalar >.

Reimplemented in Thyra::Simple2DModelEvaluator< Scalar >.

Definition at line 179 of file Thyra_StateFuncModelEvaluatorBase.hpp.

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

Returns null.

Implements Thyra::ModelEvaluator< Scalar >.

Reimplemented in Thyra::Simple2DModelEvaluator< Scalar >.

Definition at line 193 of file Thyra_StateFuncModelEvaluatorBase.hpp.

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

Returns null .

Implements Thyra::ModelEvaluator< Scalar >.

Reimplemented in Thyra::Simple2DModelEvaluator< Scalar >.

Definition at line 201 of file Thyra_StateFuncModelEvaluatorBase.hpp.

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

Ignores input and does nothing.

Implements Thyra::ModelEvaluator< Scalar >.

Definition at line 208 of file Thyra_StateFuncModelEvaluatorBase.hpp.


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