A simple serial example model which includes a parameter subvector and a response function that can be used to define an optimization problem.
More...
|
| EpetraMultiPointModelEval4DOpt (Teuchos::RCP< Epetra_Comm > epetra_comm, const double xt0=1.0, const double xt1=1.0, const double pt0=2.0, const double pt1=0.0, const double d=10.0, const double x00=1.0, const double x01=1.0, const double p00=2.0, const double p01=0.0, const double q0=0.0) |
|
void | set_p_bounds (double pL0, double pL1, double pU0, double pU1) |
|
void | set_x_bounds (double xL0, double xL1, double xU0, double xU1) |
|
virtual | ~ModelEvaluator () |
|
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.
|
|
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.
|
|
virtual Teuchos::RCP< const Epetra_Vector > | get_x_dot_init () const |
|
virtual Teuchos::RCP< const Epetra_Vector > | get_x_dotdot_init () const |
|
virtual double | get_t_init () const |
|
virtual double | getInfBound () const |
| Return the value of an infinite bound.
|
|
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 |
|
|
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 const int | NUM_E_IN_ARGS_MEMBERS =21 |
|
static const int | NUM_E_OUT_ARGS_MEMBERS =9 |
|
A simple serial example model which includes a parameter subvector and a response function that can be used to define an optimization problem.
Represents the model:
f[0] = x[0] + x[1]*x[1] - p[0];
f[1] = d_ * ( x[0]*x[0] - x[1] - p[1] );
g[0] = 0.5 * ( sqr(x[0]-xt0_) + sqr(x[1]-xt1_) + sqr(p[0]-pt0_) + sqr(p[1]-pt1_) );
where there is just one state vector x = [ x[0], x[1] ]
and one parameter subvector p = [ p[0], p[1] ]
, AND a second parameter subvector q = [ q[0] ]
for the multipoint parameter
See the function evalModel()
for more details.
Definition at line 73 of file EpetraMultiPointModelEval4DOpt.hpp.