Stokhos Package Browser (Single Doxygen Collection)  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Public Member Functions | Protected Attributes | List of all members
Stokhos::SGModelEvaluator_Adaptive Class Reference

Nonlinear, stochastic Galerkin ModelEvaluator that constructs an adapted Jacobian. More...

#include <Stokhos_SGModelEvaluator_Adaptive.hpp>

Inheritance diagram for Stokhos::SGModelEvaluator_Adaptive:
Inheritance graph
[legend]

Public Member Functions

 SGModelEvaluator_Adaptive (const Teuchos::RCP< EpetraExt::ModelEvaluator > &me_, const Teuchos::RCP< Stokhos::AdaptivityManager > &am, const Teuchos::RCP< const Stokhos::Quadrature< int, double > > &sg_quad_, const Teuchos::RCP< Stokhos::OrthogPolyExpansion< int, double > > &sg_exp_, const Teuchos::RCP< const Stokhos::ParallelData > &sg_parallel_data_, bool onlyUseLinear_, int kExpOrder_, const Teuchos::RCP< Teuchos::ParameterList > &params_)
 
 SGModelEvaluator_Adaptive (const Teuchos::RCP< EpetraExt::ModelEvaluator > &me, const Teuchos::RCP< const Stokhos::OrthogPolyBasis< int, double > > &sg_master_basis, const std::vector< Teuchos::RCP< const Stokhos::ProductBasis< int, double > > > &sg_row_dof_basis, const Teuchos::RCP< const Stokhos::Quadrature< int, double > > &sg_quad, const Teuchos::RCP< Stokhos::OrthogPolyExpansion< int, double > > &sg_exp, const Teuchos::RCP< const Stokhos::ParallelData > &sg_parallel_data, bool onlyUseLinear, int kExpOrder, const Teuchos::RCP< Teuchos::ParameterList > &params, bool scaleOP=true)
 
Teuchos::RCP< const
Stokhos::AdaptivityManager
getAdaptivityManager () const
 
- Public Member Functions inherited from Stokhos::SGModelEvaluatorBase
 SGModelEvaluatorBase ()
 
virtual ~SGModelEvaluatorBase ()
 Destructor. More...
 

Protected Attributes

Teuchos::RCP
< EpetraExt::ModelEvaluator > 
me
 Underlying model evaluator. More...
 
Teuchos::RCP< const
Stokhos::OrthogPolyBasis< int,
double > > 
sg_basis
 Stochastic Galerkin basis. More...
 
std::vector< Teuchos::RCP
< const Stokhos::ProductBasis
< int, double > > > 
sg_row_dof_basis
 
Teuchos::RCP< const
Stokhos::Quadrature< int,
double > > 
sg_quad
 Stochastic Galerkin quadrature. More...
 
Teuchos::RCP
< Stokhos::OrthogPolyExpansion
< int, double > > 
sg_exp
 Stochastic Galerkin expansion. More...
 
Teuchos::RCP
< Teuchos::ParameterList
params
 Algorithmic parameters. More...
 
unsigned int num_sg_blocks
 Number of stochastic blocks. More...
 
unsigned int num_W_blocks
 Number of W stochastic blocks (may be smaller than num_sg_blocks) More...
 
unsigned int num_p_blocks
 Number of p stochastic blocks (may be smaller than num_sg_blocks) More...
 
bool supports_x
 Whether we support x (and thus f and W) More...
 
Teuchos::RCP< const Epetra_Mapx_map
 Underlying unknown map. More...
 
Teuchos::RCP< const Epetra_Mapf_map
 Underlying residual map. More...
 
Teuchos::RCP< const
Stokhos::ParallelData
sg_parallel_data
 Parallel SG data. More...
 
Teuchos::RCP< const
EpetraExt::MultiComm > 
sg_comm
 Parallel SG communicator. More...
 
Teuchos::RCP< const
Stokhos::EpetraSparse3Tensor
epetraCijk
 Epetra Cijk. More...
 
Teuchos::RCP< const
Stokhos::EpetraSparse3Tensor
serialCijk
 Serial Epetra Cijk for dgdx*. More...
 
Teuchos::RCP< const
Stokhos::Sparse3Tensor< int,
double > > 
Cijk
 
Teuchos::RCP< const
Epetra_BlockMap
stoch_row_map
 Map for stochastic blocks. More...
 
Teuchos::RCP< const
Epetra_BlockMap
overlapped_stoch_row_map
 Overlapped map for stochastic blocks (local map) More...
 
Teuchos::RCP< const
Epetra_BlockMap
overlapped_stoch_p_map
 Overlapped map for p stochastic blocks (local map) More...
 
Teuchos::RCP< const Epetra_Mapsg_x_map
 Block SG unknown map. More...
 
Teuchos::RCP< const Epetra_Mapsg_overlapped_x_map
 Block SG overlapped unknown map. More...
 
Teuchos::RCP< const Epetra_Mapsg_f_map
 Block SG residual map. More...
 
Teuchos::RCP< const Epetra_Mapsg_overlapped_f_map
 Block SG overlapped residual map. More...
 
Teuchos::RCP< const Epetra_Mapadapted_x_map
 Adapted lock SG unknown map. More...
 
Teuchos::RCP< const Epetra_Mapadapted_overlapped_x_map
 Adapated block SG overlapped unknown map. More...
 
Teuchos::RCP< const Epetra_Mapadapted_f_map
 Adapted block SG residual map. More...
 
Teuchos::RCP< const Epetra_Mapadapted_overlapped_f_map
 Adapted block SG overlapped residual map. More...
 
Teuchos::RCP< Epetra_Importadapted_overlapped_x_importer
 Importer from SG to SG-overlapped maps. More...
 
Teuchos::RCP< Epetra_Exportadapted_overlapped_f_exporter
 Exporter from SG-overlapped to SG maps. More...
 
int num_p
 Number of parameter vectors of underlying model evaluator. More...
 
int num_p_sg
 Number of stochastic parameter vectors. More...
 
Teuchos::Array< int > sg_p_index_map
 Index map between block-p and p_sg maps. More...
 
Teuchos::Array< Teuchos::RCP
< const Epetra_Map > > 
sg_p_map
 Block SG parameter map. More...
 
Teuchos::Array< Teuchos::RCP
< Teuchos::Array< std::string > > > 
sg_p_names
 SG coefficient parameter names. More...
 
int num_g
 Number of response vectors of underlying model evaluator. More...
 
int num_g_sg
 Number of stochastic response vectors. More...
 
Teuchos::Array< int > sg_g_index_map
 Index map between block-g and g_sg maps. More...
 
Teuchos::Array< Teuchos::RCP
< const Epetra_Map > > 
sg_g_map
 Block SG response map. More...
 
Teuchos::RCP
< Stokhos::EpetraVectorOrthogPoly
x_dot_sg_blocks
 x_dot stochastic Galerkin components More...
 
Teuchos::RCP
< Stokhos::EpetraVectorOrthogPoly
x_sg_blocks
 x stochastic Galerkin components More...
 
Teuchos::RCP
< Stokhos::EpetraVectorOrthogPoly
f_sg_blocks
 f stochastic Galerkin components More...
 
Teuchos::RCP
< Stokhos::EpetraOperatorOrthogPoly
W_sg_blocks
 W stochastic Galerkin components. More...
 
Teuchos::Array< Teuchos::RCP
< Stokhos::EpetraMultiVectorOrthogPoly > > 
dfdp_sg_blocks
 
Teuchos::Array< Teuchos::RCP
< Stokhos::EpetraMultiVectorOrthogPoly > > 
dgdx_dot_sg_blocks
 dg/dxdot stochastic Galerkin components More...
 
Teuchos::Array< Teuchos::RCP
< Stokhos::EpetraMultiVectorOrthogPoly > > 
dgdx_sg_blocks
 dg/dx stochastic Galerkin components More...
 
Teuchos::RCP
< Stokhos::EpetraVectorOrthogPoly
sg_x_init
 SG initial x. More...
 
Teuchos::Array< Teuchos::RCP
< Stokhos::EpetraVectorOrthogPoly > > 
sg_p_init
 SG initial p. More...
 
bool eval_W_with_f
 Whether to always evaluate W with f. More...
 
int kExpOrder
 
bool onlyUseLinear
 
Teuchos::RCP< Epetra_CrsMatrixmy_W
 W pointer for evaluating W with f. More...
 
Teuchos::RCP< Epetra_Vectormy_x
 x pointer for evaluating preconditioner More...
 
bool scaleOP
 
Teuchos::RCP
< Stokhos::AdaptivityManager
adaptMngr
 

Overridden from EpetraExt::ModelEvaluator .

Teuchos::RCP< const Epetra_Mapget_x_map () const
 Return solution vector map. More...
 
Teuchos::RCP< const Epetra_Mapget_p_map (int l) const
 Return parameter vector map. More...
 
Teuchos::RCP< const
Teuchos::Array< std::string > > 
get_p_names (int l) const
 Return array of parameter names. More...
 
Teuchos::RCP< const Epetra_Vectorget_x_init () const
 Return initial solution. More...
 
Teuchos::RCP< const Epetra_Vectorget_p_init (int l) const
 Return initial parameters. More...
 
Teuchos::RCP< const Epetra_Mapget_f_map () const
 Return residual vector map. More...
 
Teuchos::RCP< const Epetra_Mapget_g_map (int l) const
 Return response map. More...
 
Teuchos::RCP< Epetra_Operatorcreate_W () const
 Create W = alpha*M + beta*J matrix. More...
 
InArgs createInArgs () const
 Create InArgs. More...
 
OutArgs createOutArgs () const
 Create OutArgs. More...
 
void evalModel (const InArgs &inArgs, const OutArgs &outArgs) const
 Evaluate model on InArgs. More...
 

Overridden from Stokhos::SGModelEvaluatorBase .

void set_x_sg_init (const Stokhos::EpetraVectorOrthogPoly &x_sg_in)
 Set initial solution polynomial. More...
 
Teuchos::RCP< const
Stokhos::EpetraVectorOrthogPoly
get_x_sg_init () const
 Return initial SG x. More...
 
void set_p_sg_init (int i, const Stokhos::EpetraVectorOrthogPoly &p_sg_in)
 Set initial parameter polynomial. More...
 
Teuchos::RCP< const
Stokhos::EpetraVectorOrthogPoly
get_p_sg_init (int l) const
 Return initial SG parameters. More...
 
Teuchos::Array< int > get_p_sg_map_indices () const
 Get indices of SG parameters. More...
 
Teuchos::Array< int > get_g_sg_map_indices () const
 Get indices of SG responses. More...
 
Teuchos::Array< Teuchos::RCP
< const Epetra_Map > > 
get_g_sg_base_maps () const
 Get base maps of SG responses. More...
 
Teuchos::RCP< const
Epetra_BlockMap
get_overlap_stochastic_map () const
 Return overlap stochastic map. More...
 
Teuchos::RCP< const
Epetra_BlockMap
get_x_sg_overlap_map () const
 Return x sg overlap map. More...
 
Teuchos::RCP< const Epetra_Importget_x_sg_importer () const
 Return x sg importer. More...
 
Teuchos::RCP
< Stokhos::EpetraVectorOrthogPoly
create_x_sg (Epetra_DataAccess CV=Copy, const Epetra_Vector *v=NULL) const
 Create vector orthog poly using x map and owned sg map. More...
 
Teuchos::RCP
< Stokhos::EpetraVectorOrthogPoly
create_x_sg_overlap (Epetra_DataAccess CV=Copy, const Epetra_Vector *v=NULL) const
 Create vector orthog poly using x map and overlap sg map. More...
 
Teuchos::RCP
< Stokhos::EpetraMultiVectorOrthogPoly
create_x_mv_sg (int num_vecs, Epetra_DataAccess CV=Copy, const Epetra_MultiVector *v=NULL) const
 Create vector orthog poly using x map and owned sg map. More...
 
Teuchos::RCP
< Stokhos::EpetraMultiVectorOrthogPoly
create_x_mv_sg_overlap (int num_vecs, Epetra_DataAccess CV=Copy, const Epetra_MultiVector *v=NULL) const
 Create vector orthog poly using x map and overlap sg map. More...
 
Teuchos::RCP
< Stokhos::EpetraVectorOrthogPoly
create_p_sg (int l, Epetra_DataAccess CV=Copy, const Epetra_Vector *v=0) const
 Create vector orthog poly using p map. More...
 
Teuchos::RCP
< Stokhos::EpetraVectorOrthogPoly
create_f_sg (Epetra_DataAccess CV=Copy, const Epetra_Vector *v=NULL) const
 Create vector orthog poly using f map and owned sg map. More...
 
Teuchos::RCP
< Stokhos::EpetraVectorOrthogPoly
create_f_sg_overlap (Epetra_DataAccess CV=Copy, const Epetra_Vector *v=NULL) const
 Create vector orthog poly using f map and overlap sg map. More...
 
Teuchos::RCP
< Stokhos::EpetraMultiVectorOrthogPoly
create_f_mv_sg (int num_vecs, Epetra_DataAccess CV=Copy, const Epetra_MultiVector *v=NULL) const
 Create multi-vector orthog poly using f map and owned sg map. More...
 
Teuchos::RCP
< Stokhos::EpetraMultiVectorOrthogPoly
create_f_mv_sg_overlap (int num_vecs, Epetra_DataAccess CV=Copy, const Epetra_MultiVector *v=NULL) const
 Create multi-vector orthog poly using f map and overlap sg map. More...
 
Teuchos::RCP
< Stokhos::EpetraVectorOrthogPoly
create_g_sg (int l, Epetra_DataAccess CV=Copy, const Epetra_Vector *v=NULL) const
 Create vector orthog poly using g map. More...
 
Teuchos::RCP
< Stokhos::EpetraMultiVectorOrthogPoly
create_g_mv_sg (int l, int num_vecs, Epetra_DataAccess CV=Copy, const Epetra_MultiVector *v=NULL) const
 Create multi-vector orthog poly using g map. More...
 

Detailed Description

Nonlinear, stochastic Galerkin ModelEvaluator that constructs an adapted Jacobian.

SGModelEvaluator_Adaptive is an implementation of EpetraExt::ModelEvaluator that generates a nonlinear problem from a stochastic Galerkin expansion, the Jacobian and solution vectors are interlaced. It wraps a supplied ModelEvaluator that supports the SG versions of p, x, and possibly x_dot InArgs, and f and W OutArgs, and translates those into a new nonlinear problem. It does so by concatenating all of the SG components of p, x, x_dot, and f into extended block vectors that form the parameters, solution vector, time derivative vector and residual for the new nonlinear problem. Only forming a fully-assembled SG matrix is possible. The W operator of the underlying model evaluator must be an Epetra_CrsMatrix.

Definition at line 50 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Constructor & Destructor Documentation

Stokhos::SGModelEvaluator_Adaptive::SGModelEvaluator_Adaptive ( const Teuchos::RCP< EpetraExt::ModelEvaluator > &  me_,
const Teuchos::RCP< Stokhos::AdaptivityManager > &  am,
const Teuchos::RCP< const Stokhos::Quadrature< int, double > > &  sg_quad_,
const Teuchos::RCP< Stokhos::OrthogPolyExpansion< int, double > > &  sg_exp_,
const Teuchos::RCP< const Stokhos::ParallelData > &  sg_parallel_data_,
bool  onlyUseLinear_,
int  kExpOrder_,
const Teuchos::RCP< Teuchos::ParameterList > &  params_ 
)

Definition at line 24 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Stokhos::SGModelEvaluator_Adaptive::SGModelEvaluator_Adaptive ( const Teuchos::RCP< EpetraExt::ModelEvaluator > &  me,
const Teuchos::RCP< const Stokhos::OrthogPolyBasis< int, double > > &  sg_master_basis,
const std::vector< Teuchos::RCP< const Stokhos::ProductBasis< int, double > > > &  sg_row_dof_basis,
const Teuchos::RCP< const Stokhos::Quadrature< int, double > > &  sg_quad,
const Teuchos::RCP< Stokhos::OrthogPolyExpansion< int, double > > &  sg_exp,
const Teuchos::RCP< const Stokhos::ParallelData > &  sg_parallel_data,
bool  onlyUseLinear,
int  kExpOrder,
const Teuchos::RCP< Teuchos::ParameterList > &  params,
bool  scaleOP = true 
)

Definition at line 254 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Member Function Documentation

Teuchos::RCP< const Epetra_Map > Stokhos::SGModelEvaluator_Adaptive::get_x_map ( ) const

Return solution vector map.

Definition at line 491 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< const Epetra_Map > Stokhos::SGModelEvaluator_Adaptive::get_p_map ( int  l) const

Return parameter vector map.

Definition at line 503 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< const Teuchos::Array< std::string > > Stokhos::SGModelEvaluator_Adaptive::get_p_names ( int  l) const

Return array of parameter names.

Definition at line 524 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< const Epetra_Vector > Stokhos::SGModelEvaluator_Adaptive::get_x_init ( ) const

Return initial solution.

Definition at line 537 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< const Epetra_Vector > Stokhos::SGModelEvaluator_Adaptive::get_p_init ( int  l) const

Return initial parameters.

Definition at line 547 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< const Epetra_Map > Stokhos::SGModelEvaluator_Adaptive::get_f_map ( ) const

Return residual vector map.

Definition at line 497 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< const Epetra_Map > Stokhos::SGModelEvaluator_Adaptive::get_g_map ( int  l) const

Return response map.

Definition at line 516 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< Epetra_Operator > Stokhos::SGModelEvaluator_Adaptive::create_W ( ) const

Create W = alpha*M + beta*J matrix.

Definition at line 560 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

EpetraExt::ModelEvaluator::InArgs Stokhos::SGModelEvaluator_Adaptive::createInArgs ( ) const

Create InArgs.

Definition at line 581 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

EpetraExt::ModelEvaluator::OutArgs Stokhos::SGModelEvaluator_Adaptive::createOutArgs ( ) const

Create OutArgs.

Definition at line 603 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

void Stokhos::SGModelEvaluator_Adaptive::evalModel ( const InArgs &  inArgs,
const OutArgs &  outArgs 
) const

Evaluate model on InArgs.

Definition at line 636 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

void Stokhos::SGModelEvaluator_Adaptive::set_x_sg_init ( const Stokhos::EpetraVectorOrthogPoly x_sg_in)
virtual

Set initial solution polynomial.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 908 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< const Stokhos::EpetraVectorOrthogPoly > Stokhos::SGModelEvaluator_Adaptive::get_x_sg_init ( ) const
virtual

Return initial SG x.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 915 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

void Stokhos::SGModelEvaluator_Adaptive::set_p_sg_init ( int  i,
const Stokhos::EpetraVectorOrthogPoly p_sg_in 
)
virtual

Set initial parameter polynomial.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 921 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< const Stokhos::EpetraVectorOrthogPoly > Stokhos::SGModelEvaluator_Adaptive::get_p_sg_init ( int  l) const
virtual

Return initial SG parameters.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 928 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::Array< int > Stokhos::SGModelEvaluator_Adaptive::get_p_sg_map_indices ( ) const
virtual

Get indices of SG parameters.

These indices determine which parameter vectors support SG

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 934 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::Array< int > Stokhos::SGModelEvaluator_Adaptive::get_g_sg_map_indices ( ) const
virtual

Get indices of SG responses.

These indices determine which response vectors support SG

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 940 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::Array< Teuchos::RCP< const Epetra_Map > > Stokhos::SGModelEvaluator_Adaptive::get_g_sg_base_maps ( ) const
virtual

Get base maps of SG responses.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 946 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< const Epetra_BlockMap > Stokhos::SGModelEvaluator_Adaptive::get_overlap_stochastic_map ( ) const
virtual

Return overlap stochastic map.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 955 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< const Epetra_BlockMap > Stokhos::SGModelEvaluator_Adaptive::get_x_sg_overlap_map ( ) const
virtual

Return x sg overlap map.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 961 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< const Epetra_Import > Stokhos::SGModelEvaluator_Adaptive::get_x_sg_importer ( ) const
virtual

Return x sg importer.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 967 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< Stokhos::EpetraVectorOrthogPoly > Stokhos::SGModelEvaluator_Adaptive::create_x_sg ( Epetra_DataAccess  CV = Copy,
const Epetra_Vector v = NULL 
) const
virtual

Create vector orthog poly using x map and owned sg map.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 973 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< Stokhos::EpetraVectorOrthogPoly > Stokhos::SGModelEvaluator_Adaptive::create_x_sg_overlap ( Epetra_DataAccess  CV = Copy,
const Epetra_Vector v = NULL 
) const
virtual

Create vector orthog poly using x map and overlap sg map.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 988 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPoly > Stokhos::SGModelEvaluator_Adaptive::create_x_mv_sg ( int  num_vecs,
Epetra_DataAccess  CV = Copy,
const Epetra_MultiVector v = NULL 
) const
virtual

Create vector orthog poly using x map and owned sg map.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 1004 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPoly > Stokhos::SGModelEvaluator_Adaptive::create_x_mv_sg_overlap ( int  num_vecs,
Epetra_DataAccess  CV = Copy,
const Epetra_MultiVector v = NULL 
) const
virtual

Create vector orthog poly using x map and overlap sg map.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 1020 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< Stokhos::EpetraVectorOrthogPoly > Stokhos::SGModelEvaluator_Adaptive::create_p_sg ( int  l,
Epetra_DataAccess  CV = Copy,
const Epetra_Vector v = 0 
) const
virtual

Create vector orthog poly using p map.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 1038 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< Stokhos::EpetraVectorOrthogPoly > Stokhos::SGModelEvaluator_Adaptive::create_f_sg ( Epetra_DataAccess  CV = Copy,
const Epetra_Vector v = NULL 
) const
virtual

Create vector orthog poly using f map and owned sg map.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 1060 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< Stokhos::EpetraVectorOrthogPoly > Stokhos::SGModelEvaluator_Adaptive::create_f_sg_overlap ( Epetra_DataAccess  CV = Copy,
const Epetra_Vector v = NULL 
) const
virtual

Create vector orthog poly using f map and overlap sg map.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 1075 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPoly > Stokhos::SGModelEvaluator_Adaptive::create_f_mv_sg ( int  num_vecs,
Epetra_DataAccess  CV = Copy,
const Epetra_MultiVector v = NULL 
) const
virtual

Create multi-vector orthog poly using f map and owned sg map.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 1091 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPoly > Stokhos::SGModelEvaluator_Adaptive::create_f_mv_sg_overlap ( int  num_vecs,
Epetra_DataAccess  CV = Copy,
const Epetra_MultiVector v = NULL 
) const
virtual

Create multi-vector orthog poly using f map and overlap sg map.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 1109 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< Stokhos::EpetraVectorOrthogPoly > Stokhos::SGModelEvaluator_Adaptive::create_g_sg ( int  l,
Epetra_DataAccess  CV = Copy,
const Epetra_Vector v = NULL 
) const
virtual

Create vector orthog poly using g map.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 1127 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPoly > Stokhos::SGModelEvaluator_Adaptive::create_g_mv_sg ( int  l,
int  num_vecs,
Epetra_DataAccess  CV = Copy,
const Epetra_MultiVector v = NULL 
) const
virtual

Create multi-vector orthog poly using g map.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 1151 of file Stokhos_SGModelEvaluator_Adaptive.cpp.

Teuchos::RCP<const Stokhos::AdaptivityManager> Stokhos::SGModelEvaluator_Adaptive::getAdaptivityManager ( ) const
inline

Definition at line 221 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Member Data Documentation

Teuchos::RCP<EpetraExt::ModelEvaluator> Stokhos::SGModelEvaluator_Adaptive::me
protected

Underlying model evaluator.

Definition at line 227 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const Stokhos::OrthogPolyBasis<int, double> > Stokhos::SGModelEvaluator_Adaptive::sg_basis
protected

Stochastic Galerkin basis.

Definition at line 230 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

std::vector<Teuchos::RCP<const Stokhos::ProductBasis<int,double> > > Stokhos::SGModelEvaluator_Adaptive::sg_row_dof_basis
protected

Definition at line 232 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const Stokhos::Quadrature<int,double> > Stokhos::SGModelEvaluator_Adaptive::sg_quad
protected

Stochastic Galerkin quadrature.

Definition at line 235 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<Stokhos::OrthogPolyExpansion<int,double> > Stokhos::SGModelEvaluator_Adaptive::sg_exp
protected

Stochastic Galerkin expansion.

Definition at line 238 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<Teuchos::ParameterList> Stokhos::SGModelEvaluator_Adaptive::params
protected

Algorithmic parameters.

Definition at line 241 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

unsigned int Stokhos::SGModelEvaluator_Adaptive::num_sg_blocks
protected

Number of stochastic blocks.

Definition at line 244 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

unsigned int Stokhos::SGModelEvaluator_Adaptive::num_W_blocks
protected

Number of W stochastic blocks (may be smaller than num_sg_blocks)

Definition at line 247 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

unsigned int Stokhos::SGModelEvaluator_Adaptive::num_p_blocks
protected

Number of p stochastic blocks (may be smaller than num_sg_blocks)

Definition at line 250 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

bool Stokhos::SGModelEvaluator_Adaptive::supports_x
protected

Whether we support x (and thus f and W)

Definition at line 253 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const Epetra_Map> Stokhos::SGModelEvaluator_Adaptive::x_map
protected

Underlying unknown map.

Definition at line 256 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const Epetra_Map> Stokhos::SGModelEvaluator_Adaptive::f_map
protected

Underlying residual map.

Definition at line 259 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const Stokhos::ParallelData> Stokhos::SGModelEvaluator_Adaptive::sg_parallel_data
protected

Parallel SG data.

Definition at line 262 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const EpetraExt::MultiComm> Stokhos::SGModelEvaluator_Adaptive::sg_comm
protected

Parallel SG communicator.

Definition at line 265 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const Stokhos::EpetraSparse3Tensor> Stokhos::SGModelEvaluator_Adaptive::epetraCijk
protected

Epetra Cijk.

Definition at line 268 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const Stokhos::EpetraSparse3Tensor> Stokhos::SGModelEvaluator_Adaptive::serialCijk
protected

Serial Epetra Cijk for dgdx*.

Definition at line 271 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const Stokhos::Sparse3Tensor<int,double> > Stokhos::SGModelEvaluator_Adaptive::Cijk
protected

Definition at line 273 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const Epetra_BlockMap> Stokhos::SGModelEvaluator_Adaptive::stoch_row_map
protected

Map for stochastic blocks.

Definition at line 276 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const Epetra_BlockMap> Stokhos::SGModelEvaluator_Adaptive::overlapped_stoch_row_map
protected

Overlapped map for stochastic blocks (local map)

Definition at line 279 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const Epetra_BlockMap> Stokhos::SGModelEvaluator_Adaptive::overlapped_stoch_p_map
protected

Overlapped map for p stochastic blocks (local map)

Definition at line 282 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const Epetra_Map> Stokhos::SGModelEvaluator_Adaptive::sg_x_map
protected

Block SG unknown map.

Definition at line 285 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const Epetra_Map> Stokhos::SGModelEvaluator_Adaptive::sg_overlapped_x_map
protected

Block SG overlapped unknown map.

Definition at line 288 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const Epetra_Map> Stokhos::SGModelEvaluator_Adaptive::sg_f_map
protected

Block SG residual map.

Definition at line 291 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const Epetra_Map> Stokhos::SGModelEvaluator_Adaptive::sg_overlapped_f_map
protected

Block SG overlapped residual map.

Definition at line 294 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const Epetra_Map> Stokhos::SGModelEvaluator_Adaptive::adapted_x_map
protected

Adapted lock SG unknown map.

Definition at line 297 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const Epetra_Map> Stokhos::SGModelEvaluator_Adaptive::adapted_overlapped_x_map
protected

Adapated block SG overlapped unknown map.

Definition at line 300 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const Epetra_Map> Stokhos::SGModelEvaluator_Adaptive::adapted_f_map
protected

Adapted block SG residual map.

Definition at line 303 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<const Epetra_Map> Stokhos::SGModelEvaluator_Adaptive::adapted_overlapped_f_map
protected

Adapted block SG overlapped residual map.

Definition at line 306 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<Epetra_Import> Stokhos::SGModelEvaluator_Adaptive::adapted_overlapped_x_importer
protected

Importer from SG to SG-overlapped maps.

Definition at line 309 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<Epetra_Export> Stokhos::SGModelEvaluator_Adaptive::adapted_overlapped_f_exporter
protected

Exporter from SG-overlapped to SG maps.

Definition at line 312 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

int Stokhos::SGModelEvaluator_Adaptive::num_p
protected

Number of parameter vectors of underlying model evaluator.

Definition at line 315 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

int Stokhos::SGModelEvaluator_Adaptive::num_p_sg
protected

Number of stochastic parameter vectors.

Definition at line 318 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::Array<int> Stokhos::SGModelEvaluator_Adaptive::sg_p_index_map
protected

Index map between block-p and p_sg maps.

Definition at line 321 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::Array< Teuchos::RCP<const Epetra_Map> > Stokhos::SGModelEvaluator_Adaptive::sg_p_map
protected

Block SG parameter map.

Definition at line 324 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::Array< Teuchos::RCP< Teuchos::Array<std::string> > > Stokhos::SGModelEvaluator_Adaptive::sg_p_names
protected

SG coefficient parameter names.

Definition at line 327 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

int Stokhos::SGModelEvaluator_Adaptive::num_g
protected

Number of response vectors of underlying model evaluator.

Definition at line 330 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

int Stokhos::SGModelEvaluator_Adaptive::num_g_sg
protected

Number of stochastic response vectors.

Definition at line 333 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::Array<int> Stokhos::SGModelEvaluator_Adaptive::sg_g_index_map
protected

Index map between block-g and g_sg maps.

Definition at line 336 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::Array< Teuchos::RCP<const Epetra_Map> > Stokhos::SGModelEvaluator_Adaptive::sg_g_map
protected

Block SG response map.

Definition at line 339 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP< Stokhos::EpetraVectorOrthogPoly > Stokhos::SGModelEvaluator_Adaptive::x_dot_sg_blocks
protected

x_dot stochastic Galerkin components

Definition at line 342 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP< Stokhos::EpetraVectorOrthogPoly > Stokhos::SGModelEvaluator_Adaptive::x_sg_blocks
protected

x stochastic Galerkin components

Definition at line 345 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP< Stokhos::EpetraVectorOrthogPoly > Stokhos::SGModelEvaluator_Adaptive::f_sg_blocks
mutableprotected

f stochastic Galerkin components

Definition at line 348 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP< Stokhos::EpetraOperatorOrthogPoly > Stokhos::SGModelEvaluator_Adaptive::W_sg_blocks
mutableprotected

W stochastic Galerkin components.

Definition at line 351 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::Array< Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPoly > > Stokhos::SGModelEvaluator_Adaptive::dfdp_sg_blocks
mutableprotected

Definition at line 353 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::Array< Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPoly > > Stokhos::SGModelEvaluator_Adaptive::dgdx_dot_sg_blocks
mutableprotected

dg/dxdot stochastic Galerkin components

Definition at line 356 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::Array< Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPoly > > Stokhos::SGModelEvaluator_Adaptive::dgdx_sg_blocks
mutableprotected

dg/dx stochastic Galerkin components

Definition at line 359 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<Stokhos::EpetraVectorOrthogPoly> Stokhos::SGModelEvaluator_Adaptive::sg_x_init
protected

SG initial x.

Definition at line 362 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::Array< Teuchos::RCP<Stokhos::EpetraVectorOrthogPoly> > Stokhos::SGModelEvaluator_Adaptive::sg_p_init
protected

SG initial p.

Definition at line 365 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

bool Stokhos::SGModelEvaluator_Adaptive::eval_W_with_f
protected

Whether to always evaluate W with f.

Definition at line 368 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

int Stokhos::SGModelEvaluator_Adaptive::kExpOrder
protected

Definition at line 370 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

bool Stokhos::SGModelEvaluator_Adaptive::onlyUseLinear
protected

Definition at line 371 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<Epetra_CrsMatrix> Stokhos::SGModelEvaluator_Adaptive::my_W
mutableprotected

W pointer for evaluating W with f.

Definition at line 374 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<Epetra_Vector> Stokhos::SGModelEvaluator_Adaptive::my_x
mutableprotected

x pointer for evaluating preconditioner

Definition at line 377 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

bool Stokhos::SGModelEvaluator_Adaptive::scaleOP
protected

Definition at line 379 of file Stokhos_SGModelEvaluator_Adaptive.hpp.

Teuchos::RCP<Stokhos::AdaptivityManager> Stokhos::SGModelEvaluator_Adaptive::adaptMngr
mutableprotected

Definition at line 381 of file Stokhos_SGModelEvaluator_Adaptive.hpp.


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