EpetraExt Package Browser (Single Doxygen Collection)
Development
|
Simple example ModelEvaluator subclass for a 2x2 set of parameterized nonlinear equations. More...
#include <EpetraModelEval2DSim.hpp>
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_Comm > | epetra_comm_ |
Teuchos::RCP< const Epetra_Map > | map_x_ |
Teuchos::RCP< Epetra_Vector > | x0_ |
Teuchos::RCP< Epetra_Vector > | p_ |
Teuchos::RCP< Epetra_CrsGraph > | W_graph_ |
Overridden from EpetraExt::ModelEvaluator . | |
Teuchos::RCP< const Epetra_Map > | get_x_map () const |
Teuchos::RCP< const Epetra_Map > | get_f_map () const |
Teuchos::RCP< const Epetra_Vector > | get_x_init () const |
Teuchos::RCP< Epetra_Operator > | create_W () const |
InArgs | createInArgs () const |
OutArgs | createOutArgs () const |
void | evalModel (const InArgs &inArgs, const OutArgs &outArgs) const |
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.
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.
|
virtual |
Implements EpetraExt::ModelEvaluator.
Definition at line 85 of file EpetraModelEval2DSim.cpp.
|
virtual |
Implements EpetraExt::ModelEvaluator.
Definition at line 91 of file EpetraModelEval2DSim.cpp.
|
virtual |
Reimplemented from EpetraExt::ModelEvaluator.
Definition at line 97 of file EpetraModelEval2DSim.cpp.
|
virtual |
Reimplemented from EpetraExt::ModelEvaluator.
Definition at line 103 of file EpetraModelEval2DSim.cpp.
|
virtual |
Implements EpetraExt::ModelEvaluator.
Definition at line 109 of file EpetraModelEval2DSim.cpp.
|
virtual |
Implements EpetraExt::ModelEvaluator.
Definition at line 118 of file EpetraModelEval2DSim.cpp.
|
virtual |
Implements EpetraExt::ModelEvaluator.
Definition at line 134 of file EpetraModelEval2DSim.cpp.
|
private |
Definition at line 102 of file EpetraModelEval2DSim.hpp.
|
private |
Definition at line 103 of file EpetraModelEval2DSim.hpp.
|
private |
Definition at line 105 of file EpetraModelEval2DSim.hpp.
|
private |
Definition at line 107 of file EpetraModelEval2DSim.hpp.
|
private |
Definition at line 108 of file EpetraModelEval2DSim.hpp.
|
private |
Definition at line 110 of file EpetraModelEval2DSim.hpp.
|
private |
Definition at line 111 of file EpetraModelEval2DSim.hpp.
|
private |
Definition at line 113 of file EpetraModelEval2DSim.hpp.