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 Types | Protected Attributes | Private Member Functions | List of all members
Stokhos::FullyAssembledOperator Class Reference

An Epetra operator representing the block stochastic Galerkin operator generated by fully assembling the matrix. More...

#include <Stokhos_FullyAssembledOperator.hpp>

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

Public Member Functions

 FullyAssembledOperator (const Teuchos::RCP< const EpetraExt::MultiComm > &sg_comm, const Teuchos::RCP< const Stokhos::OrthogPolyBasis< int, double > > &sg_basis, const Teuchos::RCP< const Stokhos::EpetraSparse3Tensor > &epetraCijk, const Teuchos::RCP< const Epetra_CrsGraph > &base_graph, const Teuchos::RCP< const Epetra_Map > &domain_sg_map, const Teuchos::RCP< const Epetra_Map > &range_sg_map, const Teuchos::RCP< Teuchos::ParameterList > &params)
 Constructor. More...
 
virtual ~FullyAssembledOperator ()
 Destructor. More...
 
- Public Member Functions inherited from Stokhos::SGOperator
 SGOperator ()
 Constructor. More...
 
virtual ~SGOperator ()
 Destructor. More...
 
- Public Member Functions inherited from Epetra_Operator
virtual int SetUseTranspose (bool UseTranspose)=0
 
virtual int ApplyInverse (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const =0
 
virtual double NormInf () const =0
 
virtual const char * Label () const =0
 
virtual bool UseTranspose () const =0
 
virtual bool HasNormInf () const =0
 
virtual const Epetra_CommComm () const =0
 
virtual const Epetra_MapOperatorDomainMap () const =0
 
virtual const Epetra_MapOperatorRangeMap () const =0
 

Protected Types

typedef Stokhos::Sparse3Tensor
< int, double
Cijk_type
 Short-hand for Cijk. More...
 

Protected Attributes

Teuchos::RCP< const
EpetraExt::MultiComm > 
sg_comm
 Stores SG parallel communicator. More...
 
Teuchos::RCP< const
Stokhos::OrthogPolyBasis< int,
double > > 
sg_basis
 Stochastic Galerking basis. More...
 
Teuchos::RCP< const
Stokhos::EpetraSparse3Tensor
epetraCijk
 Stores Epetra Cijk tensor. More...
 
Teuchos::RCP< const Epetra_Mapdomain_sg_map
 Stores domain SG map. More...
 
Teuchos::RCP< const Epetra_Maprange_sg_map
 Stores range SG map. More...
 
Teuchos::RCP< const Cijk_typeCijk
 Stores triple product tensor. More...
 
Teuchos::RCP
< Stokhos::EpetraOperatorOrthogPoly
block_ops
 Stores operators. More...
 
bool scale_op
 Flag indicating whether operator be scaled with <^2> More...
 
bool include_mean
 Flag indicating whether to include mean term. More...
 
bool only_use_linear
 Flag indicating whether to only use linear terms. More...
 

Private Member Functions

 FullyAssembledOperator (const FullyAssembledOperator &)
 Private to prohibit copying. More...
 
FullyAssembledOperatoroperator= (const FullyAssembledOperator &)
 Private to prohibit copying. More...
 

Stokhos::SGOperator methods

virtual void setupOperator (const Teuchos::RCP< Stokhos::EpetraOperatorOrthogPoly > &poly)
 Setup operator. More...
 
virtual Teuchos::RCP
< Stokhos::EpetraOperatorOrthogPoly
getSGPolynomial ()
 Get SG polynomial. More...
 
virtual Teuchos::RCP< const
Stokhos::EpetraOperatorOrthogPoly
getSGPolynomial () const
 Get SG polynomial. More...
 

Overloaded Epetra_Operator methods

virtual int Apply (const Epetra_MultiVector &Input, Epetra_MultiVector &Result) const
 Wrap Apply() to add a timer. More...
 

Detailed Description

An Epetra operator representing the block stochastic Galerkin operator generated by fully assembling the matrix.

Definition at line 27 of file Stokhos_FullyAssembledOperator.hpp.

Member Typedef Documentation

Short-hand for Cijk.

Definition at line 100 of file Stokhos_FullyAssembledOperator.hpp.

Constructor & Destructor Documentation

Stokhos::FullyAssembledOperator::FullyAssembledOperator ( const Teuchos::RCP< const EpetraExt::MultiComm > &  sg_comm,
const Teuchos::RCP< const Stokhos::OrthogPolyBasis< int, double > > &  sg_basis,
const Teuchos::RCP< const Stokhos::EpetraSparse3Tensor > &  epetraCijk,
const Teuchos::RCP< const Epetra_CrsGraph > &  base_graph,
const Teuchos::RCP< const Epetra_Map > &  domain_sg_map,
const Teuchos::RCP< const Epetra_Map > &  range_sg_map,
const Teuchos::RCP< Teuchos::ParameterList > &  params 
)

Constructor.

Definition at line 14 of file Stokhos_FullyAssembledOperator.cpp.

Stokhos::FullyAssembledOperator::~FullyAssembledOperator ( )
virtual

Destructor.

Definition at line 42 of file Stokhos_FullyAssembledOperator.cpp.

Stokhos::FullyAssembledOperator::FullyAssembledOperator ( const FullyAssembledOperator )
private

Private to prohibit copying.

Member Function Documentation

void Stokhos::FullyAssembledOperator::setupOperator ( const Teuchos::RCP< Stokhos::EpetraOperatorOrthogPoly > &  poly)
virtual

Setup operator.

Implements Stokhos::SGOperator.

Definition at line 48 of file Stokhos_FullyAssembledOperator.cpp.

Teuchos::RCP< Stokhos::EpetraOperatorOrthogPoly > Stokhos::FullyAssembledOperator::getSGPolynomial ( )
virtual

Get SG polynomial.

Implements Stokhos::SGOperator.

Definition at line 96 of file Stokhos_FullyAssembledOperator.cpp.

Teuchos::RCP< const Stokhos::EpetraOperatorOrthogPoly > Stokhos::FullyAssembledOperator::getSGPolynomial ( ) const
virtual

Get SG polynomial.

Implements Stokhos::SGOperator.

Definition at line 103 of file Stokhos_FullyAssembledOperator.cpp.

int Stokhos::FullyAssembledOperator::Apply ( const Epetra_MultiVector Input,
Epetra_MultiVector Result 
) const
virtual

Wrap Apply() to add a timer.

Implements Epetra_Operator.

Definition at line 110 of file Stokhos_FullyAssembledOperator.cpp.

FullyAssembledOperator& Stokhos::FullyAssembledOperator::operator= ( const FullyAssembledOperator )
private

Private to prohibit copying.

Member Data Documentation

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

Stores SG parallel communicator.

Definition at line 85 of file Stokhos_FullyAssembledOperator.hpp.

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

Stochastic Galerking basis.

Definition at line 88 of file Stokhos_FullyAssembledOperator.hpp.

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

Stores Epetra Cijk tensor.

Definition at line 91 of file Stokhos_FullyAssembledOperator.hpp.

Teuchos::RCP<const Epetra_Map> Stokhos::FullyAssembledOperator::domain_sg_map
protected

Stores domain SG map.

Definition at line 94 of file Stokhos_FullyAssembledOperator.hpp.

Teuchos::RCP<const Epetra_Map> Stokhos::FullyAssembledOperator::range_sg_map
protected

Stores range SG map.

Definition at line 97 of file Stokhos_FullyAssembledOperator.hpp.

Teuchos::RCP<const Cijk_type> Stokhos::FullyAssembledOperator::Cijk
protected

Stores triple product tensor.

Definition at line 103 of file Stokhos_FullyAssembledOperator.hpp.

Teuchos::RCP<Stokhos::EpetraOperatorOrthogPoly > Stokhos::FullyAssembledOperator::block_ops
protected

Stores operators.

Definition at line 106 of file Stokhos_FullyAssembledOperator.hpp.

bool Stokhos::FullyAssembledOperator::scale_op
protected

Flag indicating whether operator be scaled with <^2>

Definition at line 109 of file Stokhos_FullyAssembledOperator.hpp.

bool Stokhos::FullyAssembledOperator::include_mean
protected

Flag indicating whether to include mean term.

Definition at line 112 of file Stokhos_FullyAssembledOperator.hpp.

bool Stokhos::FullyAssembledOperator::only_use_linear
protected

Flag indicating whether to only use linear terms.

Definition at line 115 of file Stokhos_FullyAssembledOperator.hpp.


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