| 
    NOX
    Development
    
   | 
 


Public Member Functions | |
| AdaptiveSolutionManager (const int number_of_time_derivatives, const Teuchos::RCP< const Epetra_Map > &map_, const Teuchos::RCP< const Epetra_Map > &overlapMap_, const Teuchos::RCP< const Epetra_CrsGraph > &overlapJacGraph_) | |
| 
virtual Teuchos::RCP< const  Epetra_Vector >  | updateSolution () | 
| 
virtual Teuchos::RCP < LOCA::Epetra::Group >  | buildSolutionGroup ()=0 | 
| Build the LOCA solution group.  | |
| virtual void | projectCurrentSolution () | 
| Remap "old" solution into new data structures.  | |
| virtual void | getConvergenceData (int &KrylovIters, int &lastSolveKrylocIters, int &linSolves, double &tolAchieved) const | 
| Accessor functions.  | |
| 
virtual Teuchos::RCP < Teuchos::ParameterList >  | getAdaptParamsNonConst () | 
| 
virtual Teuchos::RCP< const  Teuchos::ParameterList >  | getAdaptParams () const | 
  Public Member Functions inherited from NOX::Epetra::AdaptiveSolutionManager | |
| AdaptiveSolutionManager (const int number_of_time_derivatives, const Teuchos::RCP< const Epetra_Map > &map_, const Teuchos::RCP< const Epetra_Map > &overlapMap_, const Teuchos::RCP< const Epetra_CrsGraph > &overlapJacGraph_) | |
| virtual bool | adaptProblem ()=0 | 
| Apply adaptation method to mesh and problem. Returns true if adaptation is performed successfully.  | |
| virtual Epetra_Vector * | getOverlapSolution (const Epetra_Vector &solution) | 
| Accessor function to Epetra_Import the solution from other PEs for output.  | |
| 
virtual Teuchos::RCP < NOX::Epetra::AdaptManager >  | getAdaptManager () | 
| Function to get the active AdaptManager.  | |
| virtual void | resizeMeshDataArrays (const Teuchos::RCP< const Epetra_Map > &map, const Teuchos::RCP< const Epetra_Map > &overlapMap, const Teuchos::RCP< const Epetra_CrsGraph > &overlapJacGraph) | 
| Function to resize the data structures when adapting.  | |
| 
virtual Teuchos::RCP< const  Epetra_Vector >  | getInitialSolution () const | 
| Accessor functions.  | |
| 
virtual Teuchos::RCP < Epetra_Vector > &  | get_initial_x () | 
| virtual void | setInitialSolution (const Teuchos::RCP< Epetra_Vector > &soln_) | 
| 
virtual Teuchos::RCP< const  Epetra_Vector >  | getInitialSolutionDot () const | 
| 
virtual Teuchos::RCP < Epetra_Vector > &  | get_initial_xdot () | 
| 
virtual Teuchos::RCP< const  Epetra_Vector >  | getInitialSolutionDotDot () const | 
| 
virtual Teuchos::RCP < Epetra_Vector > &  | get_initial_xdotdot () | 
| 
virtual Teuchos::RCP < Epetra_Vector > &  | get_overlapped_x () | 
| 
virtual Teuchos::RCP < Epetra_Vector > &  | get_overlapped_xdot () | 
| 
virtual Teuchos::RCP < Epetra_Vector > &  | get_overlapped_xdotdot () | 
| 
virtual Teuchos::RCP < Epetra_Vector > &  | get_overlapped_f () | 
| 
virtual Teuchos::RCP < Epetra_CrsMatrix > &  | get_overlapped_jac () | 
| 
virtual Teuchos::RCP < Epetra_Import > &  | get_importer () | 
| 
virtual Teuchos::RCP < Epetra_Export > &  | get_exporter () | 
Protected Attributes | |
| Teuchos::RCP< LOCA::Epetra::Group > | grp | 
| The solution group.  | |
| 
Teuchos::RCP < NOX::Epetra::LinearSystem >  | linsys | 
| The linear system used for the solution in the group.  | |
| 
Teuchos::RCP < Teuchos::ParameterList >  | adaptParams | 
| The adaptation parameter list.  | |
| 
Teuchos::RCP < Teuchos::ParameterList >  | piroParams | 
| The parent of the solution parameter list.  | |
  Protected Attributes inherited from NOX::Epetra::AdaptiveSolutionManager | |
| Teuchos::RCP< Epetra_Vector > | initial_x | 
| Initial solution vector.  | |
| Teuchos::RCP< Epetra_Vector > | initial_xdot | 
| Initial solution vector.  | |
| Teuchos::RCP< Epetra_Vector > | initial_xdotdot | 
| Initial solution vector.  | |
| Teuchos::RCP< Epetra_Import > | importer | 
| Importer for overlapped data.  | |
| Teuchos::RCP< Epetra_Export > | exporter | 
| Exporter for overlapped data.  | |
| Teuchos::RCP< Epetra_Vector > | overlapped_x | 
| Overlapped solution vector.  | |
| Teuchos::RCP< Epetra_Vector > | overlapped_xdot | 
| Overlapped time derivative vector.  | |
| Teuchos::RCP< Epetra_Vector > | overlapped_xdotdot | 
| Overlapped time acceleration vector.  | |
| Teuchos::RCP< Epetra_Vector > | overlapped_f | 
| Overlapped residual vector.  | |
| Teuchos::RCP< Epetra_CrsMatrix > | overlapped_jac | 
| Overlapped Jacobian matrix.  | |
| Teuchos::RCP< Epetra_Vector > | tmp_ovlp_sol | 
| Temporary overlapped solution vector (for output)  | |
| 
Teuchos::RCP < NOX::Epetra::AdaptManager >  | adaptManager | 
| The adaptation manager - makes the call to adapt the mesh.  | |
| Teuchos::RCP< NOX::Epetra::Vector > | currentSolution | 
| Current solution vector.  | |
| const int | num_time_deriv | 
| Number of time derivatives (x - 0, x_dot - 1, x_dotdot - 2)  | |
 1.8.5