Stokhos Package Browser (Single Doxygen Collection)
Version of the Day
|
An Epetra operator representing the block stochastic Galerkin operator generated by fully assembling the matrix. The ordering of this operator is interlaced. That means that all stochastic degrees of freedom associated with a deterministic degree of freedom are interlaced. The result is a large sparse matrix that is composed of small (relatively) dense blocks. More...
#include <Stokhos_InterlacedOperator.hpp>
Public Member Functions | |
InterlacedOperator (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< Teuchos::ParameterList > ¶ms) | |
Constructor. More... | |
virtual | ~InterlacedOperator () |
Destructor. More... | |
void | SumIntoGlobalBlock_Deterministic (double alpha, const Epetra_RowMatrix &determBlock, int Row, int Col) |
Sum into global matrix. 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 | Apply (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const =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_Comm & | Comm () const =0 |
virtual const Epetra_Map & | OperatorDomainMap () const =0 |
virtual const Epetra_Map & | OperatorRangeMap () 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 Cijk_type > | Cijk |
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... | |
int | determOffset_ |
Private Member Functions | |
InterlacedOperator (const InterlacedOperator &) | |
Private to prohibit copying. More... | |
InterlacedOperator & | operator= (const InterlacedOperator &) |
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... | |
An Epetra operator representing the block stochastic Galerkin operator generated by fully assembling the matrix. The ordering of this operator is interlaced. That means that all stochastic degrees of freedom associated with a deterministic degree of freedom are interlaced. The result is a large sparse matrix that is composed of small (relatively) dense blocks.
Definition at line 30 of file Stokhos_InterlacedOperator.hpp.
|
protected |
Short-hand for Cijk.
Definition at line 87 of file Stokhos_InterlacedOperator.hpp.
Stokhos::InterlacedOperator::InterlacedOperator | ( | 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< Teuchos::ParameterList > & | params | ||
) |
Constructor.
Definition at line 17 of file Stokhos_InterlacedOperator.cpp.
|
virtual |
Destructor.
Definition at line 42 of file Stokhos_InterlacedOperator.cpp.
|
private |
Private to prohibit copying.
|
virtual |
Setup operator.
Implements Stokhos::SGOperator.
Definition at line 48 of file Stokhos_InterlacedOperator.cpp.
|
virtual |
Get SG polynomial.
Implements Stokhos::SGOperator.
Definition at line 90 of file Stokhos_InterlacedOperator.cpp.
|
virtual |
Get SG polynomial.
Implements Stokhos::SGOperator.
Definition at line 97 of file Stokhos_InterlacedOperator.cpp.
void Stokhos::InterlacedOperator::SumIntoGlobalBlock_Deterministic | ( | double | alpha, |
const Epetra_RowMatrix & | determBlock, | ||
int | Row, | ||
int | Col | ||
) |
Sum into global matrix.
Definition at line 103 of file Stokhos_InterlacedOperator.cpp.
|
private |
Private to prohibit copying.
|
protected |
Stores SG parallel communicator.
Definition at line 78 of file Stokhos_InterlacedOperator.hpp.
|
protected |
Stochastic Galerking basis.
Definition at line 81 of file Stokhos_InterlacedOperator.hpp.
|
protected |
Stores Epetra Cijk tensor.
Definition at line 84 of file Stokhos_InterlacedOperator.hpp.
|
protected |
Stores triple product tensor.
Definition at line 90 of file Stokhos_InterlacedOperator.hpp.
|
protected |
Stores operators.
Definition at line 93 of file Stokhos_InterlacedOperator.hpp.
|
protected |
Flag indicating whether operator be scaled with <^2>
Definition at line 96 of file Stokhos_InterlacedOperator.hpp.
|
protected |
Flag indicating whether to include mean term.
Definition at line 99 of file Stokhos_InterlacedOperator.hpp.
|
protected |
Flag indicating whether to only use linear terms.
Definition at line 102 of file Stokhos_InterlacedOperator.hpp.
|
protected |
Definition at line 104 of file Stokhos_InterlacedOperator.hpp.