Public Types | Public Member Functions | Public Attributes | Protected Member Functions | Protected Attributes | Private Member Functions

Albany::Application Class Reference

#include <Albany_Application.hpp>

Collaboration diagram for Albany::Application:
Collaboration graph
[legend]

List of all members.

Public Types

enum  SolutionMethod { Steady, Transient, Continuation, Eigensolve }

Public Member Functions

 Application (const Teuchos::RCP< const Epetra_Comm > &comm, const Teuchos::RCP< Teuchos::ParameterList > &params, const Teuchos::RCP< const Epetra_Vector > &initial_guess=Teuchos::null)
 Constructor.
 ~Application ()
 Destructor.
Teuchos::RCP
< Albany::AbstractDiscretization
getDiscretization () const
 Get underlying abstract discretization.
Teuchos::RCP
< Albany::AbstractProblem
getProblem () const
 Get problem object.
Teuchos::RCP< const Epetra_Comm > getComm () const
 Get communicator.
Teuchos::RCP< const Epetra_Map > getMap () const
 Get DOF map.
Teuchos::RCP< const
Epetra_CrsGraph > 
getJacobianGraph () const
 Get Jacobian graph.
Teuchos::RCP< Epetra_Operator > getPreconditioner ()
 Get Preconditioner Operator.
Teuchos::RCP
< AAdapt::AdaptiveSolutionManager
getAdaptSolMgr ()
 Get the solution memory manager.
Teuchos::RCP< ParamLibgetParamLib ()
 Get parameter library.
SolutionMethod getSolutionMethod () const
 Get solution method.
int getNumResponses () const
 Get number of responses.
Teuchos::RCP
< AbstractResponseFunction
getResponse (int i) const
 Get response function.
bool suppliesPreconditioner () const
 Return whether problem wants to use its own preconditioner.
Teuchos::RCP
< Stokhos::OrthogPolyExpansion
< int, double > > 
getStochasticExpansion ()
 Get stochastic expansion.
void computeGlobalResidual (const double current_time, const Epetra_Vector *xdot, const Epetra_Vector *xdotdot, const Epetra_Vector &x, const Teuchos::Array< ParamVec > &p, Epetra_Vector &f)
 Intialize stochastic Galerkin method.
void computeGlobalJacobian (const double alpha, const double beta, const double omega, const double current_time, const Epetra_Vector *xdot, const Epetra_Vector *xdotdot, const Epetra_Vector &x, const Teuchos::Array< ParamVec > &p, Epetra_Vector *f, Epetra_CrsMatrix &jac)
 Compute global Jacobian.
void computeGlobalPreconditioner (const Teuchos::RCP< Epetra_CrsMatrix > &jac, const Teuchos::RCP< Epetra_Operator > &prec)
 Compute global Preconditioner.
void computeGlobalTangent (const double alpha, const double beta, const double omega, const double current_time, bool sum_derivs, const Epetra_Vector *xdot, const Epetra_Vector *xdotdot, const Epetra_Vector &x, const Teuchos::Array< ParamVec > &p, ParamVec *deriv_p, const Epetra_MultiVector *Vx, const Epetra_MultiVector *Vxdot, const Epetra_MultiVector *Vxdotdot, const Epetra_MultiVector *Vp, Epetra_Vector *f, Epetra_MultiVector *JV, Epetra_MultiVector *fp)
 Compute global Tangent.
void evaluateResponse (int response_index, const double current_time, const Epetra_Vector *xdot, const Epetra_Vector *xdotdot, const Epetra_Vector &x, const Teuchos::Array< ParamVec > &p, Epetra_Vector &g)
 Evaluate response functions.
void evaluateResponseTangent (int response_index, const double alpha, const double beta, const double omega, const double current_time, bool sum_derivs, const Epetra_Vector *xdot, const Epetra_Vector *xdotdot, const Epetra_Vector &x, const Teuchos::Array< ParamVec > &p, ParamVec *deriv_p, const Epetra_MultiVector *Vxdot, const Epetra_MultiVector *Vxdotdot, const Epetra_MultiVector *Vx, const Epetra_MultiVector *Vp, Epetra_Vector *g, Epetra_MultiVector *gx, Epetra_MultiVector *gp)
 Evaluate tangent = alpha*dg/dx*Vx + beta*dg/dxdot*Vxdot + dg/dp*Vp.
void evaluateResponseDerivative (int response_index, const double current_time, const Epetra_Vector *xdot, const Epetra_Vector *xdotdot, const Epetra_Vector &x, const Teuchos::Array< ParamVec > &p, ParamVec *deriv_p, Epetra_Vector *g, const EpetraExt::ModelEvaluator::Derivative &dg_dx, const EpetraExt::ModelEvaluator::Derivative &dg_dxdot, const EpetraExt::ModelEvaluator::Derivative &dg_dxdotdot, const EpetraExt::ModelEvaluator::Derivative &dg_dp)
 Evaluate gradient = dg/dx, dg/dxdot, dg/dp.
PHAL::AlbanyTraits::Residual::ScalarTgetValue (const std::string &n)
 Provide access to shapeParameters -- no AD.
StateManagergetStateMgr ()
 Class to manage state variables (a.k.a. history).
void evaluateStateFieldManager (const double current_time, const Epetra_Vector *xdot, const Epetra_Vector *xdotdot, const Epetra_Vector &x)
 Evaluate state field manager.
int getNumWorksets ()
 Access to number of worksets - needed for working with StateManager.
template<typename EvalT >
void loadWorksetBucketInfo (PHAL::Workset &workset, const int &ws)
 Routine to get workset (bucket) sized info needed by all Evaluation types.
void loadBasicWorksetInfo (PHAL::Workset &workset, double current_time)
 Routine to load some basic workset info needed by many Evaluation types.
void loadWorksetJacobianInfo (PHAL::Workset &workset, const double &alpha, const double &beta, const double &omega)
void loadWorksetNodesetInfo (PHAL::Workset &workset)
 Routine to load common nodeset info into workset.
void loadWorksetSidesetInfo (PHAL::Workset &workset, const int ws)
 Routine to load common sideset info into workset.
void setupBasicWorksetInfo (PHAL::Workset &workset, double current_time, const Epetra_Vector *xdot, const Epetra_Vector *xdotdot, const Epetra_Vector *x, const Teuchos::Array< ParamVec > &p)
void setupTangentWorksetInfo (PHAL::Workset &workset, double current_time, bool sum_derivs, const Epetra_Vector *xdot, const Epetra_Vector *xdotdot, const Epetra_Vector *x, const Teuchos::Array< ParamVec > &p, ParamVec *deriv_p, const Epetra_MultiVector *Vxdot, const Epetra_MultiVector *Vxdotdot, const Epetra_MultiVector *Vx, const Epetra_MultiVector *Vp)
void postRegSetup (std::string eval)

Public Attributes

bool is_adjoint

Protected Member Functions

void determinePiroSolver (const Teuchos::RCP< Teuchos::ParameterList > &topLevelParams)

Protected Attributes

Teuchos::RCP< const Epetra_Comm > comm
 Communicator.
Teuchos::RCP
< Teuchos::FancyOStream > 
out
 Output stream, defaults to pronting just Proc 0.
Teuchos::RCP
< Albany::AbstractDiscretization
disc
 Element discretization.
Teuchos::RCP
< Albany::AbstractProblem
problem
 Problem class.
Teuchos::RCP< ParamLibparamLib
 Parameter library.
Teuchos::RCP
< AAdapt::AdaptiveSolutionManager
solMgr
 Solution memory manager.
Teuchos::Array< Teuchos::RCP
< Albany::AbstractResponseFunction > > 
responses
 Response functions.
Teuchos::ArrayRCP
< Teuchos::RCP
< PHX::FieldManager
< PHAL::AlbanyTraits > > > 
fm
 Phalanx Field Manager for volumetric fills.
Teuchos::RCP
< PHX::FieldManager
< PHAL::AlbanyTraits > > 
dfm
 Phalanx Field Manager for Dirichlet Conditions.
Teuchos::ArrayRCP
< Teuchos::RCP
< PHX::FieldManager
< PHAL::AlbanyTraits > > > 
nfm
 Phalanx Field Manager for Neumann Conditions.
Teuchos::Array< Teuchos::RCP
< PHX::FieldManager
< PHAL::AlbanyTraits > > > 
sfm
 Phalanx Field Manager for states.
Teuchos::RCP< const
Stokhos::OrthogPolyBasis< int,
double > > 
sg_basis
 Stochastic Galerkin basis.
Teuchos::RCP< const
Stokhos::Quadrature< int,
double > > 
sg_quad
 Stochastic Galerkin quadrature.
Teuchos::RCP
< Stokhos::OrthogPolyExpansion
< int, double > > 
sg_expansion
 Stochastic Galerkin expansion.
Teuchos::RCP< const
EpetraExt::MultiComm > 
product_comm
 Product multi-comm.
Teuchos::RCP< const
Epetra_BlockMap > 
sg_overlap_map
 Overlap stochastic map.
Teuchos::RCP
< Stokhos::EpetraVectorOrthogPoly > 
sg_overlapped_x
 SG overlapped solution vectors.
Teuchos::RCP
< Stokhos::EpetraVectorOrthogPoly > 
sg_overlapped_xdot
 SG overlapped time derivative vectors.
Teuchos::RCP
< Stokhos::EpetraVectorOrthogPoly > 
sg_overlapped_xdotdot
Teuchos::RCP
< Stokhos::EpetraVectorOrthogPoly > 
sg_overlapped_f
 SG overlapped residual vectors.
Teuchos::RCP
< Stokhos::VectorOrthogPoly
< Epetra_CrsMatrix > > 
sg_overlapped_jac
 Overlapped Jacobian matrixs.
Teuchos::RCP
< Stokhos::ProductEpetraVector > 
mp_overlapped_x
 MP overlapped solution vectors.
Teuchos::RCP
< Stokhos::ProductEpetraVector > 
mp_overlapped_xdot
 MP overlapped time derivative vectors.
Teuchos::RCP
< Stokhos::ProductEpetraVector > 
mp_overlapped_xdotdot
Teuchos::RCP
< Stokhos::ProductEpetraVector > 
mp_overlapped_f
 MP overlapped residual vectors.
Teuchos::RCP
< Stokhos::ProductContainer
< Epetra_CrsMatrix > > 
mp_overlapped_jac
 Overlapped Jacobian matrixs.
bool physicsBasedPreconditioner
 Data for Physics-Based Preconditioners.
Teuchos::RCP
< Teuchos::ParameterList > 
tekoParams
SolutionMethod solMethod
 Type of solution method.
int writeToMatrixMarketJac
 Integer specifying whether user wants to write Jacobian to MatrixMarket file.
int writeToMatrixMarketRes
int writeToCoutJac
 Integer specifying whether user wants to write Jacobian and residual to Standard output (cout).
int writeToCoutRes
bool shapeParamsHaveBeenReset
 Shape Optimization data.
std::vector< RealTypeshapeParams
std::vector< std::string > shapeParamNames
unsigned int neq
Teuchos::RCP
< Teko::InverseLibrary > 
inverseLib
 Teko stuff.
Teuchos::RCP
< Teko::InverseFactory > 
inverseFac
Teuchos::RCP< Epetra_Operator > wrappedJac
std::vector< int > blockDecomp
std::set< std::string > setupSet
int phxGraphVisDetail
int stateGraphVisDetail
StateManager stateMgr
bool morphFromInit
bool ignore_residual_in_jacobian
double perturbBetaForDirichlets
 To prevent a singular mass matrix associated with Dirichlet.

Private Member Functions

 Application (const Application &)
 Private to prohibit copying.
Applicationoperator= (const Application &)
 Private to prohibit copying.
Teuchos::RCP< Epetra_Operator > buildWrappedOperator (const Teuchos::RCP< Epetra_Operator > &Jac, const Teuchos::RCP< Epetra_Operator > &wrapInput, bool reorder=false) const
 Call to Teko to build strided block operator.
void registerShapeParameters ()
 Utility function to set up ShapeParameters through Sacado.
void defineTimers ()

Detailed Description

Definition at line 60 of file Albany_Application.hpp.


Member Enumeration Documentation

Enumerator:
Steady 
Transient 
Continuation 
Eigensolve 

Definition at line 64 of file Albany_Application.hpp.


Constructor & Destructor Documentation

Albany::Application::Application ( const Teuchos::RCP< const Epetra_Comm > &  comm,
const Teuchos::RCP< Teuchos::ParameterList > &  params,
const Teuchos::RCP< const Epetra_Vector > &  initial_guess = Teuchos::null 
)

Constructor.

Albany::Application::~Application (  ) 

Destructor.

Definition at line 285 of file Albany_Application.cpp.

Albany::Application::Application ( const Application  )  [private]

Private to prohibit copying.


Member Function Documentation

RCP< Albany::AbstractDiscretization > Albany::Application::getDiscretization (  )  const

Get underlying abstract discretization.

Definition at line 294 of file Albany_Application.cpp.

RCP< Albany::AbstractProblem > Albany::Application::getProblem (  )  const

Get problem object.

Definition at line 301 of file Albany_Application.cpp.

RCP< const Epetra_Comm > Albany::Application::getComm (  )  const

Get communicator.

Definition at line 308 of file Albany_Application.cpp.

RCP< const Epetra_Map > Albany::Application::getMap (  )  const

Get DOF map.

Definition at line 315 of file Albany_Application.cpp.

RCP< const Epetra_CrsGraph > Albany::Application::getJacobianGraph (  )  const

Get Jacobian graph.

Definition at line 322 of file Albany_Application.cpp.

RCP< Epetra_Operator > Albany::Application::getPreconditioner (  ) 

Get Preconditioner Operator.

Definition at line 330 of file Albany_Application.cpp.

Teuchos::RCP<AAdapt::AdaptiveSolutionManager> Albany::Application::getAdaptSolMgr (  )  [inline]

Get the solution memory manager.

Definition at line 94 of file Albany_Application.hpp.

RCP< ParamLib > Albany::Application::getParamLib (  ) 

Get parameter library.

Definition at line 357 of file Albany_Application.cpp.

SolutionMethod Albany::Application::getSolutionMethod (  )  const [inline]

Get solution method.

Definition at line 100 of file Albany_Application.hpp.

int Albany::Application::getNumResponses (  )  const

Get number of responses.

Definition at line 364 of file Albany_Application.cpp.

Teuchos::RCP< Albany::AbstractResponseFunction > Albany::Application::getResponse ( int  i  )  const

Get response function.

Definition at line 370 of file Albany_Application.cpp.

bool Albany::Application::suppliesPreconditioner (  )  const

Return whether problem wants to use its own preconditioner.

Definition at line 377 of file Albany_Application.cpp.

RCP< Stokhos::OrthogPolyExpansion< int, double > > Albany::Application::getStochasticExpansion (  ) 

Get stochastic expansion.

Definition at line 384 of file Albany_Application.cpp.

void Albany::Application::computeGlobalResidual ( const double  current_time,
const Epetra_Vector *  xdot,
const Epetra_Vector *  xdotdot,
const Epetra_Vector &  x,
const Teuchos::Array< ParamVec > &  p,
Epetra_Vector &  f 
)

Intialize stochastic Galerkin method.

Compute global residual

Set xdot to NULL for steady-state problems

Definition at line 431 of file Albany_Application.cpp.

void Albany::Application::computeGlobalJacobian ( const double  alpha,
const double  beta,
const double  omega,
const double  current_time,
const Epetra_Vector *  xdot,
const Epetra_Vector *  xdotdot,
const Epetra_Vector &  x,
const Teuchos::Array< ParamVec > &  p,
Epetra_Vector *  f,
Epetra_CrsMatrix &  jac 
)

Compute global Jacobian.

Set xdot to NULL for steady-state problems

Definition at line 567 of file Albany_Application.cpp.

void Albany::Application::computeGlobalPreconditioner ( const Teuchos::RCP< Epetra_CrsMatrix > &  jac,
const Teuchos::RCP< Epetra_Operator > &  prec 
)

Compute global Preconditioner.

Set xdot to NULL for steady-state problems

void Albany::Application::computeGlobalTangent ( const double  alpha,
const double  beta,
const double  omega,
const double  current_time,
bool  sum_derivs,
const Epetra_Vector *  xdot,
const Epetra_Vector *  xdotdot,
const Epetra_Vector &  x,
const Teuchos::Array< ParamVec > &  p,
ParamVec deriv_p,
const Epetra_MultiVector *  Vx,
const Epetra_MultiVector *  Vxdot,
const Epetra_MultiVector *  Vxdotdot,
const Epetra_MultiVector *  Vp,
Epetra_Vector *  f,
Epetra_MultiVector *  JV,
Epetra_MultiVector *  fp 
)

Compute global Tangent.

Set xdot to NULL for steady-state problems

Definition at line 745 of file Albany_Application.cpp.

void Albany::Application::evaluateResponse ( int  response_index,
const double  current_time,
const Epetra_Vector *  xdot,
const Epetra_Vector *  xdotdot,
const Epetra_Vector &  x,
const Teuchos::Array< ParamVec > &  p,
Epetra_Vector &  g 
)

Evaluate response functions.

Set xdot to NULL for steady-state problems

Definition at line 1058 of file Albany_Application.cpp.

void Albany::Application::evaluateResponseTangent ( int  response_index,
const double  alpha,
const double  beta,
const double  omega,
const double  current_time,
bool  sum_derivs,
const Epetra_Vector *  xdot,
const Epetra_Vector *  xdotdot,
const Epetra_Vector &  x,
const Teuchos::Array< ParamVec > &  p,
ParamVec deriv_p,
const Epetra_MultiVector *  Vxdot,
const Epetra_MultiVector *  Vxdotdot,
const Epetra_MultiVector *  Vx,
const Epetra_MultiVector *  Vp,
Epetra_Vector *  g,
Epetra_MultiVector *  gx,
Epetra_MultiVector *  gp 
)

Evaluate tangent = alpha*dg/dx*Vx + beta*dg/dxdot*Vxdot + dg/dp*Vp.

Set xdot, dxdot_dp to NULL for steady-state problems

Definition at line 1076 of file Albany_Application.cpp.

void Albany::Application::evaluateResponseDerivative ( int  response_index,
const double  current_time,
const Epetra_Vector *  xdot,
const Epetra_Vector *  xdotdot,
const Epetra_Vector &  x,
const Teuchos::Array< ParamVec > &  p,
ParamVec deriv_p,
Epetra_Vector *  g,
const EpetraExt::ModelEvaluator::Derivative &  dg_dx,
const EpetraExt::ModelEvaluator::Derivative &  dg_dxdot,
const EpetraExt::ModelEvaluator::Derivative &  dg_dxdotdot,
const EpetraExt::ModelEvaluator::Derivative &  dg_dp 
)

Evaluate gradient = dg/dx, dg/dxdot, dg/dp.

Set xdot, dg_dxdot to NULL for steady-state problems

Definition at line 1106 of file Albany_Application.cpp.

PHAL::AlbanyTraits::Residual::ScalarT & Albany::Application::getValue ( const std::string &  n  ) 

Provide access to shapeParameters -- no AD.

Definition at line 2567 of file Albany_Application.cpp.

StateManager& Albany::Application::getStateMgr (  )  [inline]

Class to manage state variables (a.k.a. history).

Definition at line 480 of file Albany_Application.hpp.

void Albany::Application::evaluateStateFieldManager ( const double  current_time,
const Epetra_Vector *  xdot,
const Epetra_Vector *  xdotdot,
const Epetra_Vector &  x 
)

Evaluate state field manager.

Definition at line 2472 of file Albany_Application.cpp.

int Albany::Application::getNumWorksets (  )  [inline]

Access to number of worksets - needed for working with StateManager.

Definition at line 489 of file Albany_Application.hpp.

Application& Albany::Application::operator= ( const Application  )  [private]

Private to prohibit copying.

Teuchos::RCP<Epetra_Operator> Albany::Application::buildWrappedOperator ( const Teuchos::RCP< Epetra_Operator > &  Jac,
const Teuchos::RCP< Epetra_Operator > &  wrapInput,
bool  reorder = false 
) const [private]

Call to Teko to build strided block operator.

void Albany::Application::registerShapeParameters (  )  [private]

Utility function to set up ShapeParameters through Sacado.

Definition at line 2520 of file Albany_Application.cpp.

void Albany::Application::defineTimers (  )  [private]
template<typename EvalT >
void Albany::Application::loadWorksetBucketInfo ( PHAL::Workset workset,
const int &  ws 
)

Routine to get workset (bucket) sized info needed by all Evaluation types.

Definition at line 751 of file Albany_Application.hpp.

void Albany::Application::loadBasicWorksetInfo ( PHAL::Workset workset,
double  current_time 
)

Routine to load some basic workset info needed by many Evaluation types.

Definition at line 2790 of file Albany_Application.cpp.

void Albany::Application::loadWorksetJacobianInfo ( PHAL::Workset workset,
const double &  alpha,
const double &  beta,
const double &  omega 
)

Definition at line 2803 of file Albany_Application.cpp.

void Albany::Application::loadWorksetNodesetInfo ( PHAL::Workset workset  ) 

Routine to load common nodeset info into workset.

Definition at line 2813 of file Albany_Application.cpp.

void Albany::Application::loadWorksetSidesetInfo ( PHAL::Workset workset,
const int  ws 
)

Routine to load common sideset info into workset.

Definition at line 2820 of file Albany_Application.cpp.

void Albany::Application::setupBasicWorksetInfo ( PHAL::Workset workset,
double  current_time,
const Epetra_Vector *  xdot,
const Epetra_Vector *  xdotdot,
const Epetra_Vector *  x,
const Teuchos::Array< ParamVec > &  p 
)

Definition at line 2827 of file Albany_Application.cpp.

void Albany::Application::setupTangentWorksetInfo ( PHAL::Workset workset,
double  current_time,
bool  sum_derivs,
const Epetra_Vector *  xdot,
const Epetra_Vector *  xdotdot,
const Epetra_Vector *  x,
const Teuchos::Array< ParamVec > &  p,
ParamVec deriv_p,
const Epetra_MultiVector *  Vxdot,
const Epetra_MultiVector *  Vxdotdot,
const Epetra_MultiVector *  Vx,
const Epetra_MultiVector *  Vp 
)

Definition at line 2980 of file Albany_Application.cpp.

void Albany::Application::postRegSetup ( std::string  eval  ) 

Definition at line 2583 of file Albany_Application.cpp.

void Albany::Application::determinePiroSolver ( const Teuchos::RCP< Teuchos::ParameterList > &  topLevelParams  )  [protected]

Definition at line 2730 of file Albany_Application.cpp.


Member Data Documentation

Definition at line 493 of file Albany_Application.hpp.

Teuchos::RCP<const Epetra_Comm> Albany::Application::comm [protected]

Communicator.

Definition at line 621 of file Albany_Application.hpp.

Teuchos::RCP<Teuchos::FancyOStream> Albany::Application::out [protected]

Output stream, defaults to pronting just Proc 0.

Definition at line 624 of file Albany_Application.hpp.

Element discretization.

Definition at line 627 of file Albany_Application.hpp.

Problem class.

Definition at line 630 of file Albany_Application.hpp.

Teuchos::RCP<ParamLib> Albany::Application::paramLib [protected]

Parameter library.

Definition at line 633 of file Albany_Application.hpp.

Solution memory manager.

Definition at line 636 of file Albany_Application.hpp.

Teuchos::Array< Teuchos::RCP<Albany::AbstractResponseFunction> > Albany::Application::responses [protected]

Response functions.

Definition at line 639 of file Albany_Application.hpp.

Teuchos::ArrayRCP<Teuchos::RCP<PHX::FieldManager<PHAL::AlbanyTraits> > > Albany::Application::fm [protected]

Phalanx Field Manager for volumetric fills.

Definition at line 642 of file Albany_Application.hpp.

Teuchos::RCP<PHX::FieldManager<PHAL::AlbanyTraits> > Albany::Application::dfm [protected]

Phalanx Field Manager for Dirichlet Conditions.

Definition at line 645 of file Albany_Application.hpp.

Teuchos::ArrayRCP<Teuchos::RCP<PHX::FieldManager<PHAL::AlbanyTraits> > > Albany::Application::nfm [protected]

Phalanx Field Manager for Neumann Conditions.

Definition at line 648 of file Albany_Application.hpp.

Teuchos::Array< Teuchos::RCP<PHX::FieldManager<PHAL::AlbanyTraits> > > Albany::Application::sfm [protected]

Phalanx Field Manager for states.

Definition at line 651 of file Albany_Application.hpp.

Teuchos::RCP<const Stokhos::OrthogPolyBasis<int,double> > Albany::Application::sg_basis [protected]

Stochastic Galerkin basis.

Definition at line 654 of file Albany_Application.hpp.

Teuchos::RCP<const Stokhos::Quadrature<int,double> > Albany::Application::sg_quad [protected]

Stochastic Galerkin quadrature.

Definition at line 657 of file Albany_Application.hpp.

Teuchos::RCP<Stokhos::OrthogPolyExpansion<int,double> > Albany::Application::sg_expansion [protected]

Stochastic Galerkin expansion.

Definition at line 660 of file Albany_Application.hpp.

Teuchos::RCP<const EpetraExt::MultiComm> Albany::Application::product_comm [protected]

Product multi-comm.

Definition at line 663 of file Albany_Application.hpp.

Teuchos::RCP<const Epetra_BlockMap> Albany::Application::sg_overlap_map [protected]

Overlap stochastic map.

Definition at line 666 of file Albany_Application.hpp.

Teuchos::RCP< Stokhos::EpetraVectorOrthogPoly > Albany::Application::sg_overlapped_x [protected]

SG overlapped solution vectors.

Definition at line 669 of file Albany_Application.hpp.

Teuchos::RCP< Stokhos::EpetraVectorOrthogPoly > Albany::Application::sg_overlapped_xdot [protected]

SG overlapped time derivative vectors.

Definition at line 672 of file Albany_Application.hpp.

Teuchos::RCP< Stokhos::EpetraVectorOrthogPoly > Albany::Application::sg_overlapped_xdotdot [protected]

Definition at line 673 of file Albany_Application.hpp.

Teuchos::RCP< Stokhos::EpetraVectorOrthogPoly > Albany::Application::sg_overlapped_f [protected]

SG overlapped residual vectors.

Definition at line 676 of file Albany_Application.hpp.

Teuchos::RCP< Stokhos::VectorOrthogPoly<Epetra_CrsMatrix> > Albany::Application::sg_overlapped_jac [protected]

Overlapped Jacobian matrixs.

Definition at line 679 of file Albany_Application.hpp.

Teuchos::RCP< Stokhos::ProductEpetraVector > Albany::Application::mp_overlapped_x [protected]

MP overlapped solution vectors.

Definition at line 682 of file Albany_Application.hpp.

Teuchos::RCP< Stokhos::ProductEpetraVector > Albany::Application::mp_overlapped_xdot [protected]

MP overlapped time derivative vectors.

Definition at line 685 of file Albany_Application.hpp.

Teuchos::RCP< Stokhos::ProductEpetraVector > Albany::Application::mp_overlapped_xdotdot [protected]

Definition at line 686 of file Albany_Application.hpp.

Teuchos::RCP< Stokhos::ProductEpetraVector > Albany::Application::mp_overlapped_f [protected]

MP overlapped residual vectors.

Definition at line 689 of file Albany_Application.hpp.

Teuchos::RCP< Stokhos::ProductContainer<Epetra_CrsMatrix> > Albany::Application::mp_overlapped_jac [protected]

Overlapped Jacobian matrixs.

Definition at line 692 of file Albany_Application.hpp.

Data for Physics-Based Preconditioners.

Definition at line 695 of file Albany_Application.hpp.

Teuchos::RCP<Teuchos::ParameterList> Albany::Application::tekoParams [protected]

Definition at line 696 of file Albany_Application.hpp.

Type of solution method.

Definition at line 699 of file Albany_Application.hpp.

Integer specifying whether user wants to write Jacobian to MatrixMarket file.

Definition at line 707 of file Albany_Application.hpp.

Definition at line 708 of file Albany_Application.hpp.

Integer specifying whether user wants to write Jacobian and residual to Standard output (cout).

Definition at line 710 of file Albany_Application.hpp.

Definition at line 711 of file Albany_Application.hpp.

Shape Optimization data.

Definition at line 714 of file Albany_Application.hpp.

std::vector<RealType> Albany::Application::shapeParams [protected]

Definition at line 715 of file Albany_Application.hpp.

std::vector<std::string> Albany::Application::shapeParamNames [protected]

Definition at line 716 of file Albany_Application.hpp.

unsigned int Albany::Application::neq [protected]

Definition at line 721 of file Albany_Application.hpp.

Teuchos::RCP<Teko::InverseLibrary> Albany::Application::inverseLib [protected]

Teko stuff.

Definition at line 724 of file Albany_Application.hpp.

Teuchos::RCP<Teko::InverseFactory> Albany::Application::inverseFac [protected]

Definition at line 725 of file Albany_Application.hpp.

Teuchos::RCP<Epetra_Operator> Albany::Application::wrappedJac [protected]

Definition at line 726 of file Albany_Application.hpp.

std::vector<int> Albany::Application::blockDecomp [protected]

Definition at line 727 of file Albany_Application.hpp.

std::set<std::string> Albany::Application::setupSet [protected]

Definition at line 729 of file Albany_Application.hpp.

int Albany::Application::phxGraphVisDetail [mutable, protected]

Definition at line 730 of file Albany_Application.hpp.

int Albany::Application::stateGraphVisDetail [mutable, protected]

Definition at line 731 of file Albany_Application.hpp.

Definition at line 733 of file Albany_Application.hpp.

Definition at line 735 of file Albany_Application.hpp.

Definition at line 736 of file Albany_Application.hpp.

To prevent a singular mass matrix associated with Dirichlet.

Definition at line 740 of file Albany_Application.hpp.


The documentation for this class was generated from the following files: