EpetraExt Package Browser (Single Doxygen Collection)  Development
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Public Member Functions | Private Attributes | List of all members
EpetraModelEval2DSim Class Reference

Simple example ModelEvaluator subclass for a 2x2 set of parameterized nonlinear equations. More...

#include <EpetraModelEval2DSim.hpp>

Inheritance diagram for EpetraModelEval2DSim:
Inheritance graph
[legend]

Public Member Functions

 EpetraModelEval2DSim (const double d=10.0, const double p0=2.0, const double p1=0.0, const double x00=1.0, const double x01=1.0, const bool showGetInvalidArg=false)
 
- Public Member Functions inherited from EpetraExt::ModelEvaluator
virtual ~ModelEvaluator ()
 
virtual Teuchos::RCP< const
Epetra_Map
get_p_map (int l) const
 . More...
 
virtual Teuchos::RCP< const
Teuchos::Array< std::string > > 
get_p_names (int l) const
 Get the names of the parameters associated with parameter subvector l if available. More...
 
virtual Teuchos::RCP< const
Epetra_Map
get_g_map (int j) const
 . More...
 
virtual Teuchos::ArrayView
< const std::string > 
get_g_names (int j) const
 Get the names of the response functions associated with response subvector j if available. More...
 
virtual Teuchos::RCP< const
Epetra_Vector
get_x_dot_init () const
 
virtual Teuchos::RCP< const
Epetra_Vector
get_x_dotdot_init () const
 
virtual Teuchos::RCP< const
Epetra_Vector
get_p_init (int l) const
 
virtual double get_t_init () const
 
virtual double getInfBound () const
 Return the value of an infinite bound. More...
 
virtual Teuchos::RCP< const
Epetra_Vector
get_x_lower_bounds () const
 
virtual Teuchos::RCP< const
Epetra_Vector
get_x_upper_bounds () const
 
virtual Teuchos::RCP< const
Epetra_Vector
get_p_lower_bounds (int l) const
 
virtual Teuchos::RCP< const
Epetra_Vector
get_p_upper_bounds (int l) const
 
virtual double get_t_lower_bound () const
 
virtual double get_t_upper_bound () const
 
virtual Teuchos::RCP
< EpetraExt::ModelEvaluator::Preconditioner
create_WPrec () const
 
virtual Teuchos::RCP
< Epetra_Operator
create_DfDp_op (int l) const
 
virtual Teuchos::RCP
< Epetra_Operator
create_DgDx_dot_op (int j) const
 
virtual Teuchos::RCP
< Epetra_Operator
create_DgDx_dotdot_op (int j) const
 
virtual Teuchos::RCP
< Epetra_Operator
create_DgDx_op (int j) const
 
virtual Teuchos::RCP
< Epetra_Operator
create_DgDp_op (int j, int l) const
 
- Public Member Functions inherited from Teuchos::Describable
DescribableStreamManipulatorState describe (const Describable &describable, const EVerbosityLevel verbLevel=Describable::verbLevel_default)
 
std::ostream & operator<< (std::ostream &os, const DescribableStreamManipulatorState &d)
 
virtual std::string description () const
 
virtual void describe (FancyOStream &out, const EVerbosityLevel verbLevel=verbLevel_default) const
 
void describe (std::ostream &out, const EVerbosityLevel verbLevel=verbLevel_default) const
 
virtual ~Describable ()
 
 LabeledObject ()
 
virtual ~LabeledObject ()
 
virtual void setObjectLabel (const std::string &objectLabel)
 
virtual std::string getObjectLabel () const
 

Private Attributes

double d_
 
bool showGetInvalidArg_
 
bool isInitialized_
 
Teuchos::RCP< const Epetra_Commepetra_comm_
 
Teuchos::RCP< const Epetra_Mapmap_x_
 
Teuchos::RCP< Epetra_Vectorx0_
 
Teuchos::RCP< Epetra_Vectorp_
 
Teuchos::RCP< Epetra_CrsGraphW_graph_
 

Overridden from EpetraExt::ModelEvaluator .

Teuchos::RCP< const Epetra_Mapget_x_map () const
 
Teuchos::RCP< const Epetra_Mapget_f_map () const
 
Teuchos::RCP< const Epetra_Vectorget_x_init () const
 
Teuchos::RCP< Epetra_Operatorcreate_W () const
 
InArgs createInArgs () const
 
OutArgs createOutArgs () const
 
void evalModel (const InArgs &inArgs, const OutArgs &outArgs) const
 

Additional Inherited Members

- Public Types inherited from EpetraExt::ModelEvaluator
enum  EInArgsMembers {
  IN_ARG_x_dot, IN_ARG_x, IN_ARG_x_dot_poly, IN_ARG_x_poly,
  IN_ARG_x_dot_sg, IN_ARG_x_sg, 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, IN_ARG_x_dotdot, IN_ARG_x_dotdot_poly, IN_ARG_x_dotdot_sg,
  IN_ARG_x_dotdot_mp, IN_ARG_omega, IN_ARG_sg_basis, IN_ARG_sg_quadrature,
  IN_ARG_sg_expansion
}
 
enum  EInArgs_p_sg { IN_ARG_p_sg }
 
enum  EInArgs_p_mp { IN_ARG_p_mp }
 
enum  EEvalType { EVAL_TYPE_EXACT, EVAL_TYPE_APPROX_DERIV, EVAL_TYPE_VERY_APPROX_DERIV }
 
enum  EDerivativeMultiVectorOrientation { DERIV_MV_BY_COL, DERIV_TRANS_MV_BY_ROW }
 
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_poly, OUT_ARG_f_sg,
  OUT_ARG_W_sg, OUT_ARG_f_mp, OUT_ARG_W_mp, OUT_ARG_WPrec
}
 
enum  EOutArgsDfDp { OUT_ARG_DfDp }
 
enum  EOutArgsDgDx_dot { OUT_ARG_DgDx_dot }
 
enum  EOutArgsDgDx_dotdot { OUT_ARG_DgDx_dotdot }
 
enum  EOutArgsDgDx { OUT_ARG_DgDx }
 
enum  EOutArgsDgDp { OUT_ARG_DgDp }
 
enum  EOutArgsDfDp_sg { OUT_ARG_DfDp_sg }
 
enum  EOutArgs_g_sg { OUT_ARG_g_sg }
 
enum  EOutArgsDgDx_dot_sg { OUT_ARG_DgDx_dot_sg }
 
enum  EOutArgsDgDx_dotdot_sg { OUT_ARG_DgDx_dotdot_sg }
 
enum  EOutArgsDgDx_sg { OUT_ARG_DgDx_sg }
 
enum  EOutArgsDgDp_sg { OUT_ARG_DgDp_sg }
 
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_dotdot_mp { OUT_ARG_DgDx_dotdot_mp }
 
enum  EOutArgsDgDx_mp { OUT_ARG_DgDx_mp }
 
enum  EOutArgsDgDp_mp { OUT_ARG_DgDp_mp }
 
typedef Teuchos::RCP< const
Stokhos::ProductEpetraVector > 
mp_const_vector_t
 
typedef Teuchos::RCP< const
Stokhos::ProductEpetraMultiVector > 
mp_const_multivector_t
 
typedef Teuchos::RCP< const
Stokhos::ProductEpetraOperator > 
mp_const_operator_t
 
typedef Teuchos::RCP
< Stokhos::ProductEpetraVector > 
mp_vector_t
 
typedef Teuchos::RCP
< Stokhos::ProductEpetraMultiVector > 
mp_multivector_t
 
typedef Teuchos::RCP
< Stokhos::ProductEpetraOperator > 
mp_operator_t
 
- Static Public Attributes inherited from EpetraExt::ModelEvaluator
static const int NUM_E_IN_ARGS_MEMBERS =21
 
static const int NUM_E_OUT_ARGS_MEMBERS =9
 
- Static Public Attributes inherited from Teuchos::Describable
static const EVerbosityLevel verbLevel_default
 

Detailed Description

Simple example ModelEvaluator subclass for a 2x2 set of parameterized nonlinear equations.

The equations modeled are:

   f[0] =       x[0]      + x[1]*x[1] - p[0];
   f[1] = d * ( x[0]*x[0] - x[1]      - p[1] );

Definition at line 64 of file EpetraModelEval2DSim.hpp.

Constructor & Destructor Documentation

EpetraModelEval2DSim::EpetraModelEval2DSim ( const double  d = 10.0,
const double  p0 = 2.0,
const double  p1 = 0.0,
const double  x00 = 1.0,
const double  x01 = 1.0,
const bool  showGetInvalidArg = false 
)

Definition at line 49 of file EpetraModelEval2DSim.cpp.

Member Function Documentation

Teuchos::RCP< const Epetra_Map > EpetraModelEval2DSim::get_x_map ( ) const
virtual

Implements EpetraExt::ModelEvaluator.

Definition at line 85 of file EpetraModelEval2DSim.cpp.

Teuchos::RCP< const Epetra_Map > EpetraModelEval2DSim::get_f_map ( ) const
virtual

Implements EpetraExt::ModelEvaluator.

Definition at line 91 of file EpetraModelEval2DSim.cpp.

Teuchos::RCP< const Epetra_Vector > EpetraModelEval2DSim::get_x_init ( ) const
virtual

Reimplemented from EpetraExt::ModelEvaluator.

Definition at line 97 of file EpetraModelEval2DSim.cpp.

Teuchos::RCP< Epetra_Operator > EpetraModelEval2DSim::create_W ( ) const
virtual

Reimplemented from EpetraExt::ModelEvaluator.

Definition at line 103 of file EpetraModelEval2DSim.cpp.

EpetraExt::ModelEvaluator::InArgs EpetraModelEval2DSim::createInArgs ( ) const
virtual

Implements EpetraExt::ModelEvaluator.

Definition at line 109 of file EpetraModelEval2DSim.cpp.

EpetraExt::ModelEvaluator::OutArgs EpetraModelEval2DSim::createOutArgs ( ) const
virtual

Implements EpetraExt::ModelEvaluator.

Definition at line 118 of file EpetraModelEval2DSim.cpp.

void EpetraModelEval2DSim::evalModel ( const InArgs inArgs,
const OutArgs outArgs 
) const
virtual

Implements EpetraExt::ModelEvaluator.

Definition at line 134 of file EpetraModelEval2DSim.cpp.

Member Data Documentation

double EpetraModelEval2DSim::d_
private

Definition at line 102 of file EpetraModelEval2DSim.hpp.

bool EpetraModelEval2DSim::showGetInvalidArg_
private

Definition at line 103 of file EpetraModelEval2DSim.hpp.

bool EpetraModelEval2DSim::isInitialized_
private

Definition at line 105 of file EpetraModelEval2DSim.hpp.

Teuchos::RCP<const Epetra_Comm> EpetraModelEval2DSim::epetra_comm_
private

Definition at line 107 of file EpetraModelEval2DSim.hpp.

Teuchos::RCP<const Epetra_Map> EpetraModelEval2DSim::map_x_
private

Definition at line 108 of file EpetraModelEval2DSim.hpp.

Teuchos::RCP<Epetra_Vector> EpetraModelEval2DSim::x0_
private

Definition at line 110 of file EpetraModelEval2DSim.hpp.

Teuchos::RCP<Epetra_Vector> EpetraModelEval2DSim::p_
private

Definition at line 111 of file EpetraModelEval2DSim.hpp.

Teuchos::RCP<Epetra_CrsGraph> EpetraModelEval2DSim::W_graph_
private

Definition at line 113 of file EpetraModelEval2DSim.hpp.


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