Stokhos Package Browser (Single Doxygen Collection) Version of the Day
Loading...
Searching...
No Matches
Public Member Functions | List of all members
Stokhos::SGModelEvaluator_Interlaced Class Reference

Nonlinear, stochastic Galerkin ModelEvaluator that constructs a interlaced Jacobian. More...

#include <Stokhos_SGModelEvaluator_Interlaced.hpp>

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

Public Member Functions

 SGModelEvaluator_Interlaced (const Teuchos::RCP< EpetraExt::ModelEvaluator > &me, const Teuchos::RCP< const Stokhos::OrthogPolyBasis< int, double > > &sg_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, const Teuchos::RCP< Teuchos::ParameterList > &params, bool scaleOP=true)
 
- Public Member Functions inherited from Stokhos::SGModelEvaluatorBase
 SGModelEvaluatorBase ()
 
virtual ~SGModelEvaluatorBase ()
 Destructor.
 

Overridden from Stokhos::SGModelEvaluatorBase .

Teuchos::RCP< EpetraExt::ModelEvaluator > me
 Underlying model evaluator.
 
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_exp
 Stochastic Galerkin expansion.
 
Teuchos::RCP< Teuchos::ParameterList > params
 Algorithmic parameters.
 
unsigned int num_sg_blocks
 Number of stochastic blocks.
 
unsigned int num_W_blocks
 Number of W stochastic blocks (may be smaller than num_sg_blocks)
 
unsigned int num_p_blocks
 Number of p stochastic blocks (may be smaller than num_sg_blocks)
 
bool supports_x
 Whether we support x (and thus f and W)
 
Teuchos::RCP< const Epetra_Mapx_map
 Underlying unknown map.
 
Teuchos::RCP< const Epetra_Mapf_map
 Underlying residual map.
 
Teuchos::RCP< const Stokhos::ParallelDatasg_parallel_data
 Parallel SG data.
 
Teuchos::RCP< const EpetraExt::MultiComm > sg_comm
 Parallel SG communicator.
 
Teuchos::RCP< const Stokhos::EpetraSparse3TensorepetraCijk
 Epetra Cijk.
 
Teuchos::RCP< const Stokhos::EpetraSparse3TensorserialCijk
 Serial Epetra Cijk for dgdx*.
 
Teuchos::RCP< const Epetra_BlockMapstoch_row_map
 Map for stochastic blocks.
 
Teuchos::RCP< const Epetra_BlockMapoverlapped_stoch_row_map
 Overlapped map for stochastic blocks (local map)
 
Teuchos::RCP< const Epetra_BlockMapoverlapped_stoch_p_map
 Overlapped map for p stochastic blocks (local map)
 
Teuchos::RCP< const Epetra_Mapinterlace_x_map
 Block SG unknown map.
 
Teuchos::RCP< const Epetra_Mapinterlace_overlapped_x_map
 Block SG overlapped unknown map.
 
Teuchos::RCP< const Epetra_Mapinterlace_f_map
 Block SG residual map.
 
Teuchos::RCP< const Epetra_Mapinterlace_overlapped_f_map
 Block SG overlapped residual map.
 
Teuchos::RCP< Epetra_Importinterlace_overlapped_x_importer
 Importer from SG to SG-overlapped maps.
 
Teuchos::RCP< Epetra_Exportinterlace_overlapped_f_exporter
 Exporter from SG-overlapped to SG maps.
 
int num_p
 Number of parameter vectors of underlying model evaluator.
 
int num_p_sg
 Number of stochastic parameter vectors.
 
Teuchos::Array< int > sg_p_index_map
 Index map between block-p and p_sg maps.
 
Teuchos::Array< Teuchos::RCP< const Epetra_Map > > sg_p_map
 Block SG parameter map.
 
Teuchos::Array< Teuchos::RCP< Teuchos::Array< std::string > > > sg_p_names
 SG coefficient parameter names.
 
int num_g
 Number of response vectors of underlying model evaluator.
 
int num_g_sg
 Number of stochastic response vectors.
 
Teuchos::Array< int > sg_g_index_map
 Index map between block-g and g_sg maps.
 
Teuchos::Array< Teuchos::RCP< const Epetra_Map > > sg_g_map
 Block SG response map.
 
Teuchos::RCP< Stokhos::EpetraVectorOrthogPolyx_dot_sg_blocks
 x_dot stochastic Galerkin components
 
Teuchos::RCP< Stokhos::EpetraVectorOrthogPolyx_sg_blocks
 x stochastic Galerkin components
 
Teuchos::RCP< Stokhos::EpetraVectorOrthogPolyf_sg_blocks
 f stochastic Galerkin components
 
Teuchos::RCP< Stokhos::EpetraOperatorOrthogPolyW_sg_blocks
 W stochastic Galerkin components.
 
Teuchos::Array< Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPoly > > dfdp_sg_blocks
 
Teuchos::Array< Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPoly > > dgdx_dot_sg_blocks
 dg/dxdot stochastic Galerkin components
 
Teuchos::Array< Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPoly > > dgdx_sg_blocks
 dg/dx stochastic Galerkin components
 
Teuchos::RCP< Stokhos::EpetraVectorOrthogPolysg_x_init
 SG initial x.
 
Teuchos::Array< Teuchos::RCP< Stokhos::EpetraVectorOrthogPoly > > sg_p_init
 SG initial p.
 
bool eval_W_with_f
 Whether to always evaluate W with f.
 
Teuchos::RCP< Stokhos::SGOperatormy_W
 W pointer for evaluating W with f.
 
Teuchos::RCP< Epetra_Vectormy_x
 x pointer for evaluating preconditioner
 
bool scaleOP
 
void set_x_sg_init (const Stokhos::EpetraVectorOrthogPoly &x_sg_in)
 Set initial solution polynomial.
 
Teuchos::RCP< const Stokhos::EpetraVectorOrthogPolyget_x_sg_init () const
 Return initial SG x.
 
void set_p_sg_init (int i, const Stokhos::EpetraVectorOrthogPoly &p_sg_in)
 Set initial parameter polynomial.
 
Teuchos::RCP< const Stokhos::EpetraVectorOrthogPolyget_p_sg_init (int l) const
 Return initial SG parameters.
 
Teuchos::Array< int > get_p_sg_map_indices () const
 Get indices of SG parameters.
 
Teuchos::Array< int > get_g_sg_map_indices () const
 Get indices of SG responses.
 
Teuchos::Array< Teuchos::RCP< const Epetra_Map > > get_g_sg_base_maps () const
 Get base maps of SG responses.
 
Teuchos::RCP< const Epetra_BlockMapget_overlap_stochastic_map () const
 Return overlap stochastic map.
 
Teuchos::RCP< const Epetra_BlockMapget_x_sg_overlap_map () const
 Return x sg overlap map.
 
Teuchos::RCP< const Epetra_Importget_x_sg_importer () const
 Return x sg importer.
 
Teuchos::RCP< Stokhos::EpetraVectorOrthogPolycreate_x_sg (Epetra_DataAccess CV=Copy, const Epetra_Vector *v=NULL) const
 Create vector orthog poly using x map and owned sg map.
 
Teuchos::RCP< Stokhos::EpetraVectorOrthogPolycreate_x_sg_overlap (Epetra_DataAccess CV=Copy, const Epetra_Vector *v=NULL) const
 Create vector orthog poly using x map and overlap sg map.
 
Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPolycreate_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.
 
Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPolycreate_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.
 
Teuchos::RCP< Stokhos::EpetraVectorOrthogPolycreate_p_sg (int l, Epetra_DataAccess CV=Copy, const Epetra_Vector *v=NULL) const
 Create vector orthog poly using p map.
 
Teuchos::RCP< Stokhos::EpetraVectorOrthogPolycreate_f_sg (Epetra_DataAccess CV=Copy, const Epetra_Vector *v=NULL) const
 Create vector orthog poly using f map and owned sg map.
 
Teuchos::RCP< Stokhos::EpetraVectorOrthogPolycreate_f_sg_overlap (Epetra_DataAccess CV=Copy, const Epetra_Vector *v=NULL) const
 Create vector orthog poly using f map and overlap sg map.
 
Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPolycreate_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.
 
Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPolycreate_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.
 
Teuchos::RCP< Stokhos::EpetraVectorOrthogPolycreate_g_sg (int l, Epetra_DataAccess CV=Copy, const Epetra_Vector *v=NULL) const
 Create vector orthog poly using g map.
 
Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPolycreate_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.
 
static Teuchos::RCP< Epetra_MapbuildInterlaceMap (const Epetra_BlockMap &determ_map, const Epetra_BlockMap &stocha_map)
 
static void copyToInterlacedVector (const Stokhos::EpetraVectorOrthogPoly &x_sg, Epetra_Vector &x)
 
static void copyToPolyOrthogVector (const Epetra_Vector &x, Stokhos::EpetraVectorOrthogPoly &x_sg)
 

Overridden from EpetraExt::ModelEvaluator .

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

Detailed Description

Nonlinear, stochastic Galerkin ModelEvaluator that constructs a interlaced Jacobian.

SGModelEvaluator_Interlaced 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 82 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

Constructor & Destructor Documentation

◆ SGModelEvaluator_Interlaced()

Stokhos::SGModelEvaluator_Interlaced::SGModelEvaluator_Interlaced ( const Teuchos::RCP< EpetraExt::ModelEvaluator > & me,
const Teuchos::RCP< const Stokhos::OrthogPolyBasis< int, double > > & sg_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,
const Teuchos::RCP< Teuchos::ParameterList > & params,
bool scaleOP = true )

Definition at line 56 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

Member Function Documentation

◆ get_x_map()

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

Return solution vector map.

Definition at line 272 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ get_p_map()

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

Return parameter vector map.

Definition at line 284 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ get_p_names()

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

Return array of parameter names.

Definition at line 305 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ get_x_init()

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

Return initial solution.

Definition at line 318 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ get_p_init()

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

Return initial parameters.

Definition at line 324 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ get_f_map()

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

Return residual vector map.

Definition at line 278 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ get_g_map()

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

Return response map.

Definition at line 297 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ create_W()

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

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

Definition at line 337 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ createInArgs()

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

Create InArgs.

Definition at line 357 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ createOutArgs()

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

Create OutArgs.

Definition at line 379 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ evalModel()

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

Evaluate model on InArgs.

Definition at line 410 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ set_x_sg_init()

void Stokhos::SGModelEvaluator_Interlaced::set_x_sg_init ( const Stokhos::EpetraVectorOrthogPoly & x_sg_in)
virtual

Set initial solution polynomial.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 696 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ get_x_sg_init()

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

Return initial SG x.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 703 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ set_p_sg_init()

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

Set initial parameter polynomial.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 709 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ get_p_sg_init()

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

Return initial SG parameters.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 716 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ get_p_sg_map_indices()

Teuchos::Array< int > Stokhos::SGModelEvaluator_Interlaced::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 722 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ get_g_sg_map_indices()

Teuchos::Array< int > Stokhos::SGModelEvaluator_Interlaced::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 728 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ get_g_sg_base_maps()

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

Get base maps of SG responses.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 734 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ get_overlap_stochastic_map()

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

Return overlap stochastic map.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 743 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ get_x_sg_overlap_map()

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

Return x sg overlap map.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 749 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ get_x_sg_importer()

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

Return x sg importer.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 755 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ create_x_sg()

Teuchos::RCP< Stokhos::EpetraVectorOrthogPoly > Stokhos::SGModelEvaluator_Interlaced::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 761 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ create_x_sg_overlap()

Teuchos::RCP< Stokhos::EpetraVectorOrthogPoly > Stokhos::SGModelEvaluator_Interlaced::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 776 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ create_x_mv_sg()

Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPoly > Stokhos::SGModelEvaluator_Interlaced::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 792 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ create_x_mv_sg_overlap()

Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPoly > Stokhos::SGModelEvaluator_Interlaced::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 808 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ create_p_sg()

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

Create vector orthog poly using p map.

Implements Stokhos::SGModelEvaluatorBase.

Definition at line 826 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ create_f_sg()

Teuchos::RCP< Stokhos::EpetraVectorOrthogPoly > Stokhos::SGModelEvaluator_Interlaced::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 848 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ create_f_sg_overlap()

Teuchos::RCP< Stokhos::EpetraVectorOrthogPoly > Stokhos::SGModelEvaluator_Interlaced::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 863 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ create_f_mv_sg()

Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPoly > Stokhos::SGModelEvaluator_Interlaced::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 879 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ create_f_mv_sg_overlap()

Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPoly > Stokhos::SGModelEvaluator_Interlaced::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 897 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ create_g_sg()

Teuchos::RCP< Stokhos::EpetraVectorOrthogPoly > Stokhos::SGModelEvaluator_Interlaced::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 915 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ create_g_mv_sg()

Teuchos::RCP< Stokhos::EpetraMultiVectorOrthogPoly > Stokhos::SGModelEvaluator_Interlaced::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 939 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ buildInterlaceMap()

Teuchos::RCP< Epetra_Map > Stokhos::SGModelEvaluator_Interlaced::buildInterlaceMap ( const Epetra_BlockMap & determ_map,
const Epetra_BlockMap & stocha_map )
static

Build an interlaced map containing stochastic degrees of freedom for each element of the detministic map. This is not an adaptive map!

Definition at line 964 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ copyToInterlacedVector()

void Stokhos::SGModelEvaluator_Interlaced::copyToInterlacedVector ( const Stokhos::EpetraVectorOrthogPoly & x_sg,
Epetra_Vector & x )
static

Copy from a SG EpetraPolyOrthogVector object to an interlaced vector

Definition at line 982 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

◆ copyToPolyOrthogVector()

void Stokhos::SGModelEvaluator_Interlaced::copyToPolyOrthogVector ( const Epetra_Vector & x,
Stokhos::EpetraVectorOrthogPoly & x_sg )
static

Copy from a SG EpetraPolyOrthogVector object to an interlaced vector

Definition at line 997 of file Stokhos_SGModelEvaluator_Interlaced.cpp.

Member Data Documentation

◆ me

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

Underlying model evaluator.

Definition at line 260 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ sg_basis

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

Stochastic Galerkin basis.

Definition at line 263 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ sg_quad

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

Stochastic Galerkin quadrature.

Definition at line 266 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ sg_exp

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

Stochastic Galerkin expansion.

Definition at line 269 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ params

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

Algorithmic parameters.

Definition at line 272 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ num_sg_blocks

unsigned int Stokhos::SGModelEvaluator_Interlaced::num_sg_blocks
protected

Number of stochastic blocks.

Definition at line 275 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ num_W_blocks

unsigned int Stokhos::SGModelEvaluator_Interlaced::num_W_blocks
protected

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

Definition at line 278 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ num_p_blocks

unsigned int Stokhos::SGModelEvaluator_Interlaced::num_p_blocks
protected

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

Definition at line 281 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ supports_x

bool Stokhos::SGModelEvaluator_Interlaced::supports_x
protected

Whether we support x (and thus f and W)

Definition at line 284 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ x_map

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

Underlying unknown map.

Definition at line 287 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ f_map

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

Underlying residual map.

Definition at line 290 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ sg_parallel_data

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

Parallel SG data.

Definition at line 293 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ sg_comm

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

Parallel SG communicator.

Definition at line 296 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ epetraCijk

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

Epetra Cijk.

Definition at line 299 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ serialCijk

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

Serial Epetra Cijk for dgdx*.

Definition at line 302 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ stoch_row_map

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

Map for stochastic blocks.

Definition at line 305 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ overlapped_stoch_row_map

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

Overlapped map for stochastic blocks (local map)

Definition at line 308 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ overlapped_stoch_p_map

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

Overlapped map for p stochastic blocks (local map)

Definition at line 311 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ interlace_x_map

Teuchos::RCP<const Epetra_Map> Stokhos::SGModelEvaluator_Interlaced::interlace_x_map
protected

Block SG unknown map.

Definition at line 314 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ interlace_overlapped_x_map

Teuchos::RCP<const Epetra_Map> Stokhos::SGModelEvaluator_Interlaced::interlace_overlapped_x_map
protected

Block SG overlapped unknown map.

Definition at line 317 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ interlace_f_map

Teuchos::RCP<const Epetra_Map> Stokhos::SGModelEvaluator_Interlaced::interlace_f_map
protected

Block SG residual map.

Definition at line 320 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ interlace_overlapped_f_map

Teuchos::RCP<const Epetra_Map> Stokhos::SGModelEvaluator_Interlaced::interlace_overlapped_f_map
protected

Block SG overlapped residual map.

Definition at line 323 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ interlace_overlapped_x_importer

Teuchos::RCP<Epetra_Import> Stokhos::SGModelEvaluator_Interlaced::interlace_overlapped_x_importer
protected

Importer from SG to SG-overlapped maps.

Definition at line 326 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ interlace_overlapped_f_exporter

Teuchos::RCP<Epetra_Export> Stokhos::SGModelEvaluator_Interlaced::interlace_overlapped_f_exporter
protected

Exporter from SG-overlapped to SG maps.

Definition at line 329 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ num_p

int Stokhos::SGModelEvaluator_Interlaced::num_p
protected

Number of parameter vectors of underlying model evaluator.

Definition at line 332 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ num_p_sg

int Stokhos::SGModelEvaluator_Interlaced::num_p_sg
protected

Number of stochastic parameter vectors.

Definition at line 335 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ sg_p_index_map

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

Index map between block-p and p_sg maps.

Definition at line 338 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ sg_p_map

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

Block SG parameter map.

Definition at line 341 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ sg_p_names

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

SG coefficient parameter names.

Definition at line 344 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ num_g

int Stokhos::SGModelEvaluator_Interlaced::num_g
protected

Number of response vectors of underlying model evaluator.

Definition at line 347 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ num_g_sg

int Stokhos::SGModelEvaluator_Interlaced::num_g_sg
protected

Number of stochastic response vectors.

Definition at line 350 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ sg_g_index_map

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

Index map between block-g and g_sg maps.

Definition at line 353 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ sg_g_map

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

Block SG response map.

Definition at line 356 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ x_dot_sg_blocks

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

x_dot stochastic Galerkin components

Definition at line 359 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ x_sg_blocks

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

x stochastic Galerkin components

Definition at line 362 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ f_sg_blocks

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

f stochastic Galerkin components

Definition at line 365 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ W_sg_blocks

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

W stochastic Galerkin components.

Definition at line 368 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ dfdp_sg_blocks

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

Definition at line 370 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ dgdx_dot_sg_blocks

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

dg/dxdot stochastic Galerkin components

Definition at line 373 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ dgdx_sg_blocks

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

dg/dx stochastic Galerkin components

Definition at line 376 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ sg_x_init

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

SG initial x.

Definition at line 379 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ sg_p_init

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

SG initial p.

Definition at line 382 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ eval_W_with_f

bool Stokhos::SGModelEvaluator_Interlaced::eval_W_with_f
protected

Whether to always evaluate W with f.

Definition at line 385 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ my_W

Teuchos::RCP<Stokhos::SGOperator> Stokhos::SGModelEvaluator_Interlaced::my_W
mutableprotected

W pointer for evaluating W with f.

Definition at line 388 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ my_x

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

x pointer for evaluating preconditioner

Definition at line 391 of file Stokhos_SGModelEvaluator_Interlaced.hpp.

◆ scaleOP

bool Stokhos::SGModelEvaluator_Interlaced::scaleOP
protected

Definition at line 393 of file Stokhos_SGModelEvaluator_Interlaced.hpp.


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