| 
    EpetraExt Package Browser (Single Doxygen Collection)
    Development
    
   | 
 
#include <EpetraExt_MultiPointModelEvaluator.h>

Public Member Functions | |
| ~MultiPointModelEvaluator () | |
  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_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 < 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 | |
| Teuchos::RCP < EpetraExt::ModelEvaluator >  | underlyingME | 
| Teuchos::RCP < EpetraExt::MultiComm >  | globalComm | 
| Pointer to the global (full XYZT) communicator.  More... | |
| Teuchos::RCP< std::vector < Teuchos::RCP< Epetra_Vector > > >  | q_vec | 
| Array of parameter vectors that define the multi-point problem.  More... | |
| Teuchos::RCP< Epetra_RowMatrix > | split_W | 
| Pointer to split (spatial) Jacobian matrix.  More... | |
| Teuchos::RCP< Epetra_Vector > | split_x | 
| Split (spatial) input vector – local storage.  More... | |
| Teuchos::RCP< Epetra_Vector > | split_f | 
| Split (spatial) residual vector – local storage.  More... | |
| Teuchos::RCP< Epetra_Vector > | split_g | 
| Split vector of response functions – local storage.  More... | |
| Teuchos::RCP< Epetra_MultiVector > | split_DfDp | 
| Split sensitivity vector – local storage.  More... | |
| Teuchos::RCP< Epetra_MultiVector > | split_DgDx | 
| Split sensitivity vector – local storage.  More... | |
| Teuchos::RCP< Epetra_MultiVector > | split_DgDp | 
| EpetraExt::ModelEvaluator::DerivativeMultiVector * | derivMV_DfDp | 
| EpetraExt::ModelEvaluator::Derivative * | deriv_DfDp | 
| EpetraExt::ModelEvaluator::DerivativeMultiVector * | derivMV_DgDx | 
| EpetraExt::ModelEvaluator::Derivative * | deriv_DgDx | 
| EpetraExt::ModelEvaluator::DerivativeMultiVector * | derivMV_DgDp | 
| EpetraExt::ModelEvaluator::Derivative * | deriv_DgDp | 
| Teuchos::RCP < EpetraExt::BlockCrsMatrix >  | block_W | 
| Pointer to global XYZT Jacobian matrix.  More... | |
| EpetraExt::BlockVector * | block_x | 
| Pointer to global multipoint solution vector – local storage.  More... | |
| EpetraExt::BlockVector * | block_f | 
| Pointer to global multipoint residual vector – local storage.  More... | |
| EpetraExt::BlockMultiVector * | block_DfDp | 
| Pointer to global multipoint DfDp multi vector – local storage.  More... | |
| EpetraExt::BlockMultiVector * | block_DgDx | 
| Pointer to global multipoint DfDp multi vector – local storage.  More... | |
| Teuchos::RCP < EpetraExt::BlockVector >  | solution_init | 
| Pointer to initial multipoint solution vector.  More... | |
| int | underlyingNg | 
| Number of g vectors supported by underlyingME, often used as a bool.  More... | |
| int | timeStepsOnTimeDomain | 
| Number of time steps computed on each time domain.  More... | |
| int | numTimeDomains | 
| Total number of time step domains.  More... | |
| int | timeDomain | 
| Time domain on current processor.  More... | |
| std::vector< std::vector< int > > * | rowStencil_int | 
| Stencil for each row of global XYZT Jacobian matrix.  More... | |
| std::vector< std::vector< long  long > > *  | rowStencil_LL | 
| std::vector< int > * | rowIndex_int | 
| Set of indices into global XYZT Jacobian matrix.  More... | |
| std::vector< long long > * | rowIndex_LL | 
| bool | longlong | 
| EDerivativeMultiVectorOrientation | orientation_DgDp | 
| Some local data.  More... | |
| int | num_dg0dp0 | 
| int | num_g0 | 
| int | num_p0 | 
| Teuchos::RCP< std::vector < Teuchos::RCP< Epetra_Vector > > >  | matching_vec | 
| Array of vectors that have data for g-matching optimization problem.  More... | |
| bool | matchingProblem | 
Constructors/initializers | |
| MultiPointModelEvaluator (Teuchos::RCP< EpetraExt::ModelEvaluator > underlyingME_, const Teuchos::RCP< EpetraExt::MultiComm > &globalComm_, const std::vector< Epetra_Vector * > initGuessVec, Teuchos::RCP< std::vector< Teuchos::RCP< Epetra_Vector > > > qvec, Teuchos::RCP< std::vector< Teuchos::RCP< Epetra_Vector > > > matching_vec=Teuchos::null) | |
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_x_init () const | 
| Teuchos::RCP< const Epetra_Vector > | get_p_init (int l) const | 
| Teuchos::RCP< Epetra_Operator > | create_W () const | 
| InArgs | createInArgs () const | 
| OutArgs | createOutArgs () const | 
| void | evalModel (const InArgs &inArgs, const OutArgs &outArgs) const | 
Definition at line 68 of file EpetraExt_MultiPointModelEvaluator.h.
| EpetraExt::MultiPointModelEvaluator::MultiPointModelEvaluator | ( | Teuchos::RCP< EpetraExt::ModelEvaluator > | underlyingME_, | 
| const Teuchos::RCP< EpetraExt::MultiComm > & | globalComm_, | ||
| const std::vector< Epetra_Vector * > | initGuessVec, | ||
| Teuchos::RCP< std::vector< Teuchos::RCP< Epetra_Vector > > > | qvec, | ||
| Teuchos::RCP< std::vector< Teuchos::RCP< Epetra_Vector > > > | matching_vec = Teuchos::null  | 
        ||
| ) | 
Definition at line 48 of file EpetraExt_MultiPointModelEvaluator.cpp.
| EpetraExt::MultiPointModelEvaluator::~MultiPointModelEvaluator | ( | ) | 
Definition at line 210 of file EpetraExt_MultiPointModelEvaluator.cpp.
      
  | 
  virtual | 
Implements EpetraExt::ModelEvaluator.
Definition at line 235 of file EpetraExt_MultiPointModelEvaluator.cpp.
      
  | 
  virtual | 
Implements EpetraExt::ModelEvaluator.
Definition at line 240 of file EpetraExt_MultiPointModelEvaluator.cpp.
      
  | 
  virtual | 
.
Reimplemented from EpetraExt::ModelEvaluator.
Definition at line 245 of file EpetraExt_MultiPointModelEvaluator.cpp.
      
  | 
  virtual | 
.
Reimplemented from EpetraExt::ModelEvaluator.
Definition at line 250 of file EpetraExt_MultiPointModelEvaluator.cpp.
      
  | 
  virtual | 
Reimplemented from EpetraExt::ModelEvaluator.
Definition at line 255 of file EpetraExt_MultiPointModelEvaluator.cpp.
      
  | 
  virtual | 
Reimplemented from EpetraExt::ModelEvaluator.
Definition at line 260 of file EpetraExt_MultiPointModelEvaluator.cpp.
      
  | 
  virtual | 
Reimplemented from EpetraExt::ModelEvaluator.
Definition at line 265 of file EpetraExt_MultiPointModelEvaluator.cpp.
      
  | 
  virtual | 
Implements EpetraExt::ModelEvaluator.
Definition at line 270 of file EpetraExt_MultiPointModelEvaluator.cpp.
      
  | 
  virtual | 
Implements EpetraExt::ModelEvaluator.
Definition at line 280 of file EpetraExt_MultiPointModelEvaluator.cpp.
      
  | 
  virtual | 
Implements EpetraExt::ModelEvaluator.
Definition at line 325 of file EpetraExt_MultiPointModelEvaluator.cpp.
      
  | 
  private | 
Definition at line 118 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Pointer to the global (full XYZT) communicator.
Definition at line 121 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Array of parameter vectors that define the multi-point problem.
Definition at line 124 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Pointer to split (spatial) Jacobian matrix.
Definition at line 127 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Split (spatial) input vector – local storage.
Definition at line 130 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Split (spatial) residual vector – local storage.
Definition at line 133 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Split vector of response functions – local storage.
Definition at line 136 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Split sensitivity vector – local storage.
Definition at line 139 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Split sensitivity vector – local storage.
Definition at line 142 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Definition at line 143 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Definition at line 145 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Definition at line 146 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Definition at line 147 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Definition at line 148 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Definition at line 149 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Definition at line 150 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Pointer to global XYZT Jacobian matrix.
Definition at line 153 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Pointer to global multipoint solution vector – local storage.
Definition at line 156 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Pointer to global multipoint residual vector – local storage.
Definition at line 159 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Pointer to global multipoint DfDp multi vector – local storage.
Definition at line 162 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Pointer to global multipoint DfDp multi vector – local storage.
Definition at line 165 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Pointer to initial multipoint solution vector.
Definition at line 168 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Number of g vectors supported by underlyingME, often used as a bool.
Definition at line 171 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Number of time steps computed on each time domain.
Definition at line 174 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Total number of time step domains.
Definition at line 177 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Time domain on current processor.
Definition at line 180 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Stencil for each row of global XYZT Jacobian matrix.
Used in creating global XYZT Jacobian matrix for different finite difference schemes.
Definition at line 189 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Definition at line 192 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Set of indices into global XYZT Jacobian matrix.
Definition at line 197 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Definition at line 200 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Definition at line 202 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Some local data.
Definition at line 205 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Definition at line 206 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Definition at line 207 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Definition at line 208 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Array of vectors that have data for g-matching optimization problem.
Definition at line 211 of file EpetraExt_MultiPointModelEvaluator.h.
      
  | 
  private | 
Definition at line 212 of file EpetraExt_MultiPointModelEvaluator.h.
 1.8.5