| EpetraExt Package Browser (Single Doxygen Collection)
    Development
    | 
A simple quadratic parallel response-only model evaluator. More...
#include <EpetraExt_DiagonalQuadraticResponseOnlyModelEvaluator.hpp>

| Public Member Functions | |
| DiagonalQuadraticResponseOnlyModelEvaluator (const Teuchos::RCP< Epetra_Comm > &comm, const int localDim, const double &pt, const double &p0, const double &scale) | |
|  Public Member Functions inherited from EpetraExt::ModelEvaluator | |
| 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.  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_init () const | 
| 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.  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 < Epetra_Operator > | create_W () const | 
| If supported, create a Epetra_Operatorobject forWto be evaluated.  More... | |
| 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 Member Functions | |
| DiagonalQuadraticResponseOnlyModelEvaluator () | |
| Private Attributes | |
| Teuchos::RCP< const Epetra_Comm > | epetra_comm_ | 
| Teuchos::RCP< const Epetra_Map > | map_p_ | 
| Teuchos::RCP< const Epetra_Map > | map_g_ | 
| double | scale_ | 
| Teuchos::RCP< Epetra_Vector > | pt_ | 
| Teuchos::RCP< Epetra_Vector > | p0_ | 
| Related Functions | |
| (Note that these are not member functions.) | |
| Teuchos::RCP < DiagonalQuadraticResponseOnlyModelEvaluator > | diagonalQuadraticResponseOnlyModelEvaluator (const Teuchos::RCP< Epetra_Comm > &comm, const int localDim, const double &pt, const double &p0, const double &scale) | 
| Nonmember constructor.  More... | |
| 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_Map > | get_p_map (int l) const | 
| .  More... | |
| Teuchos::RCP< const Epetra_Map > | get_g_map (int j) const | 
| .  More... | |
| Teuchos::RCP< const Epetra_Vector > | get_p_init (int l) const | 
| InArgs | createInArgs () const | 
| OutArgs | createOutArgs () const | 
| void | evalModel (const InArgs &inArgs, const OutArgs &outArgs) const | 
A simple quadratic parallel response-only model evaluator.
Represents the model:
g[0] = 0.5 * (p-pt)^T * (p-pt)
See the function evalModel() for more details. 
Definition at line 70 of file EpetraExt_DiagonalQuadraticResponseOnlyModelEvaluator.hpp.
| EpetraExt::DiagonalQuadraticResponseOnlyModelEvaluator::DiagonalQuadraticResponseOnlyModelEvaluator | ( | const Teuchos::RCP< Epetra_Comm > & | comm, | 
| const int | localDim, | ||
| const double & | pt, | ||
| const double & | p0, | ||
| const double & | scale | ||
| ) | 
Definition at line 54 of file EpetraExt_DiagonalQuadraticResponseOnlyModelEvaluator.cpp.
| 
 | private | 
| 
 | virtual | 
Implements EpetraExt::ModelEvaluator.
Definition at line 81 of file EpetraExt_DiagonalQuadraticResponseOnlyModelEvaluator.cpp.
| 
 | virtual | 
Implements EpetraExt::ModelEvaluator.
Definition at line 88 of file EpetraExt_DiagonalQuadraticResponseOnlyModelEvaluator.cpp.
| 
 | virtual | 
.
Reimplemented from EpetraExt::ModelEvaluator.
Definition at line 95 of file EpetraExt_DiagonalQuadraticResponseOnlyModelEvaluator.cpp.
| 
 | virtual | 
.
Reimplemented from EpetraExt::ModelEvaluator.
Definition at line 103 of file EpetraExt_DiagonalQuadraticResponseOnlyModelEvaluator.cpp.
| 
 | virtual | 
Reimplemented from EpetraExt::ModelEvaluator.
Definition at line 111 of file EpetraExt_DiagonalQuadraticResponseOnlyModelEvaluator.cpp.
| 
 | virtual | 
Implements EpetraExt::ModelEvaluator.
Definition at line 119 of file EpetraExt_DiagonalQuadraticResponseOnlyModelEvaluator.cpp.
| 
 | virtual | 
Implements EpetraExt::ModelEvaluator.
Definition at line 129 of file EpetraExt_DiagonalQuadraticResponseOnlyModelEvaluator.cpp.
| 
 | virtual | 
Implements EpetraExt::ModelEvaluator.
Definition at line 146 of file EpetraExt_DiagonalQuadraticResponseOnlyModelEvaluator.cpp.
| 
 | related | 
Nonmember constructor.
Definition at line 126 of file EpetraExt_DiagonalQuadraticResponseOnlyModelEvaluator.hpp.
| 
 | private | 
Definition at line 105 of file EpetraExt_DiagonalQuadraticResponseOnlyModelEvaluator.hpp.
| 
 | private | 
Definition at line 106 of file EpetraExt_DiagonalQuadraticResponseOnlyModelEvaluator.hpp.
| 
 | private | 
Definition at line 107 of file EpetraExt_DiagonalQuadraticResponseOnlyModelEvaluator.hpp.
| 
 | private | 
Definition at line 109 of file EpetraExt_DiagonalQuadraticResponseOnlyModelEvaluator.hpp.
| 
 | private | 
Definition at line 111 of file EpetraExt_DiagonalQuadraticResponseOnlyModelEvaluator.hpp.
| 
 | private | 
Definition at line 112 of file EpetraExt_DiagonalQuadraticResponseOnlyModelEvaluator.hpp.
 1.8.5
 1.8.5