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::KLMatrixFreeOperator Class Reference

An Epetra operator representing the block stochastic Galerkin operator. More...

#include <Stokhos_KLMatrixFreeOperator.hpp>

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

Public Member Functions

 KLMatrixFreeOperator (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_Map > &domain_base_map, const Teuchos::RCP< const Epetra_Map > &range_base_map, 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 ~KLMatrixFreeOperator ()
 Destructor. More...
 
- Public Member Functions inherited from Stokhos::SGOperator
 SGOperator ()
 Constructor. More...
 
virtual ~SGOperator ()
 Destructor. More...
 

Protected Types

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

Protected Attributes

std::string label
 Label for operator. More...
 
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_base_map
 Stores domain base map. More...
 
Teuchos::RCP< const Epetra_Maprange_base_map
 Stores range base map. 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...
 
bool is_stoch_parallel
 Whether we have parallelism over stochastic blocks. More...
 
Teuchos::RCP< Epetra_Mapglobal_col_map
 Stores operator column SG map. More...
 
Teuchos::RCP< Epetra_Mapglobal_col_map_trans
 Stores operator column SG map for transpose. More...
 
Teuchos::RCP< const
Epetra_BlockMap
stoch_col_map
 Stores stochastic part of column map. More...
 
Teuchos::RCP< Epetra_Importcol_importer
 Importer from domain map to column map. More...
 
Teuchos::RCP< Epetra_Importcol_importer_trans
 Importer from range map to column 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 useTranspose
 Flag indicating whether transpose was selected. More...
 
int expansion_size
 Number of terms in expansion. More...
 
int num_blocks
 Number of Jacobian blocks (not necessarily equal to expansion_size) More...
 
int max_num_mat_vec
 Maximum number of matvecs in Apply. More...
 
Teuchos::RCP< Epetra_MultiVectorinput_col
 Temporary to store result of importing input into column map. More...
 
Teuchos::RCP< Epetra_MultiVectorinput_col_trans
 Temporary to store result of importing input into column map (transpose) More...
 
Teuchos::Array< Teuchos::RCP
< const Epetra_MultiVector > > 
input_block
 MultiVectors for each block for Apply() input. More...
 
Teuchos::Array< Teuchos::RCP
< Epetra_MultiVector > > 
result_block
 MultiVectors for each block for Apply() result. More...
 
Teuchos::RCP< Epetra_MultiVectortmp
 Temporary multivector used in Apply() More...
 
Teuchos::RCP< Epetra_MultiVectortmp_trans
 Temporary multivector used in Apply() for transpose. More...
 
Cijk_type::k_iterator k_begin
 Starting k iterator. More...
 
Cijk_type::k_iterator k_end
 Ending k iterator. More...
 

Private Member Functions

 KLMatrixFreeOperator (const KLMatrixFreeOperator &)
 Private to prohibit copying. More...
 
KLMatrixFreeOperatoroperator= (const KLMatrixFreeOperator &)
 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...
 

Epetra_Operator methods

virtual int SetUseTranspose (bool UseTranspose)
 Set to true if the transpose of the operator is requested. More...
 
virtual int Apply (const Epetra_MultiVector &Input, Epetra_MultiVector &Result) const
 Returns the result of a Epetra_Operator applied to a Epetra_MultiVector Input in Result as described above. More...
 
virtual int ApplyInverse (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const
 Returns the result of the inverse of the operator applied to a Epetra_MultiVector Input in Result as described above. More...
 
virtual double NormInf () const
 Returns an approximate infinity norm of the operator matrix. More...
 
virtual const char * Label () const
 Returns a character std::string describing the operator. More...
 
virtual bool UseTranspose () const
 Returns the current UseTranspose setting. More...
 
virtual bool HasNormInf () const
 Returns true if the this object can provide an approximate Inf-norm, false otherwise. More...
 
virtual const Epetra_CommComm () const
 Returns a reference to the Epetra_Comm communicator associated with this operator. More...
 
virtual const Epetra_MapOperatorDomainMap () const
 Returns the Epetra_Map object associated with the domain of this matrix operator. More...
 
virtual const Epetra_MapOperatorRangeMap () const
 Returns the Epetra_Map object associated with the range of this matrix operator. More...
 

Detailed Description

An Epetra operator representing the block stochastic Galerkin operator.

Definition at line 28 of file Stokhos_KLMatrixFreeOperator.hpp.

Member Typedef Documentation

Short-hand for Cijk.

Definition at line 171 of file Stokhos_KLMatrixFreeOperator.hpp.

Constructor & Destructor Documentation

Stokhos::KLMatrixFreeOperator::KLMatrixFreeOperator ( 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_Map > &  domain_base_map,
const Teuchos::RCP< const Epetra_Map > &  range_base_map,
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 15 of file Stokhos_KLMatrixFreeOperator.cpp.

Stokhos::KLMatrixFreeOperator::~KLMatrixFreeOperator ( )
virtual

Destructor.

Definition at line 101 of file Stokhos_KLMatrixFreeOperator.cpp.

Stokhos::KLMatrixFreeOperator::KLMatrixFreeOperator ( const KLMatrixFreeOperator )
private

Private to prohibit copying.

Member Function Documentation

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

Setup operator.

Implements Stokhos::SGOperator.

Definition at line 107 of file Stokhos_KLMatrixFreeOperator.cpp.

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

Get SG polynomial.

Implements Stokhos::SGOperator.

Definition at line 116 of file Stokhos_KLMatrixFreeOperator.cpp.

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

Get SG polynomial.

Implements Stokhos::SGOperator.

Definition at line 123 of file Stokhos_KLMatrixFreeOperator.cpp.

int Stokhos::KLMatrixFreeOperator::SetUseTranspose ( bool  UseTranspose)
virtual

Set to true if the transpose of the operator is requested.

Implements Epetra_Operator.

Definition at line 130 of file Stokhos_KLMatrixFreeOperator.cpp.

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

Returns the result of a Epetra_Operator applied to a Epetra_MultiVector Input in Result as described above.

Implements Epetra_Operator.

Definition at line 141 of file Stokhos_KLMatrixFreeOperator.cpp.

int Stokhos::KLMatrixFreeOperator::ApplyInverse ( const Epetra_MultiVector X,
Epetra_MultiVector Y 
) const
virtual

Returns the result of the inverse of the operator applied to a Epetra_MultiVector Input in Result as described above.

Implements Epetra_Operator.

Definition at line 285 of file Stokhos_KLMatrixFreeOperator.cpp.

double Stokhos::KLMatrixFreeOperator::NormInf ( ) const
virtual

Returns an approximate infinity norm of the operator matrix.

Implements Epetra_Operator.

Definition at line 293 of file Stokhos_KLMatrixFreeOperator.cpp.

const char * Stokhos::KLMatrixFreeOperator::Label ( ) const
virtual

Returns a character std::string describing the operator.

Implements Epetra_Operator.

Definition at line 301 of file Stokhos_KLMatrixFreeOperator.cpp.

bool Stokhos::KLMatrixFreeOperator::UseTranspose ( ) const
virtual

Returns the current UseTranspose setting.

Implements Epetra_Operator.

Definition at line 308 of file Stokhos_KLMatrixFreeOperator.cpp.

bool Stokhos::KLMatrixFreeOperator::HasNormInf ( ) const
virtual

Returns true if the this object can provide an approximate Inf-norm, false otherwise.

Implements Epetra_Operator.

Definition at line 315 of file Stokhos_KLMatrixFreeOperator.cpp.

const Epetra_Comm & Stokhos::KLMatrixFreeOperator::Comm ( ) const
virtual

Returns a reference to the Epetra_Comm communicator associated with this operator.

Implements Epetra_Operator.

Definition at line 322 of file Stokhos_KLMatrixFreeOperator.cpp.

const Epetra_Map & Stokhos::KLMatrixFreeOperator::OperatorDomainMap ( ) const
virtual

Returns the Epetra_Map object associated with the domain of this matrix operator.

Implements Epetra_Operator.

Definition at line 328 of file Stokhos_KLMatrixFreeOperator.cpp.

const Epetra_Map & Stokhos::KLMatrixFreeOperator::OperatorRangeMap ( ) const
virtual

Returns the Epetra_Map object associated with the range of this matrix operator.

Implements Epetra_Operator.

Definition at line 337 of file Stokhos_KLMatrixFreeOperator.cpp.

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

Private to prohibit copying.

Member Data Documentation

std::string Stokhos::KLMatrixFreeOperator::label
protected

Label for operator.

Definition at line 129 of file Stokhos_KLMatrixFreeOperator.hpp.

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

Stores SG parallel communicator.

Definition at line 132 of file Stokhos_KLMatrixFreeOperator.hpp.

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

Stochastic Galerking basis.

Definition at line 135 of file Stokhos_KLMatrixFreeOperator.hpp.

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

Stores Epetra Cijk tensor.

Definition at line 138 of file Stokhos_KLMatrixFreeOperator.hpp.

Teuchos::RCP<const Epetra_Map> Stokhos::KLMatrixFreeOperator::domain_base_map
protected

Stores domain base map.

Definition at line 141 of file Stokhos_KLMatrixFreeOperator.hpp.

Teuchos::RCP<const Epetra_Map> Stokhos::KLMatrixFreeOperator::range_base_map
protected

Stores range base map.

Definition at line 144 of file Stokhos_KLMatrixFreeOperator.hpp.

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

Stores domain SG map.

Definition at line 147 of file Stokhos_KLMatrixFreeOperator.hpp.

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

Stores range SG map.

Definition at line 150 of file Stokhos_KLMatrixFreeOperator.hpp.

bool Stokhos::KLMatrixFreeOperator::is_stoch_parallel
protected

Whether we have parallelism over stochastic blocks.

Definition at line 153 of file Stokhos_KLMatrixFreeOperator.hpp.

Teuchos::RCP<Epetra_Map> Stokhos::KLMatrixFreeOperator::global_col_map
protected

Stores operator column SG map.

Definition at line 156 of file Stokhos_KLMatrixFreeOperator.hpp.

Teuchos::RCP<Epetra_Map> Stokhos::KLMatrixFreeOperator::global_col_map_trans
protected

Stores operator column SG map for transpose.

Definition at line 159 of file Stokhos_KLMatrixFreeOperator.hpp.

Teuchos::RCP<const Epetra_BlockMap> Stokhos::KLMatrixFreeOperator::stoch_col_map
protected

Stores stochastic part of column map.

Definition at line 162 of file Stokhos_KLMatrixFreeOperator.hpp.

Teuchos::RCP<Epetra_Import> Stokhos::KLMatrixFreeOperator::col_importer
protected

Importer from domain map to column map.

Definition at line 165 of file Stokhos_KLMatrixFreeOperator.hpp.

Teuchos::RCP<Epetra_Import> Stokhos::KLMatrixFreeOperator::col_importer_trans
protected

Importer from range map to column map.

Definition at line 168 of file Stokhos_KLMatrixFreeOperator.hpp.

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

Stores triple product tensor.

Definition at line 174 of file Stokhos_KLMatrixFreeOperator.hpp.

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

Stores operators.

Definition at line 177 of file Stokhos_KLMatrixFreeOperator.hpp.

bool Stokhos::KLMatrixFreeOperator::scale_op
protected

Flag indicating whether operator be scaled with <^2>

Definition at line 180 of file Stokhos_KLMatrixFreeOperator.hpp.

bool Stokhos::KLMatrixFreeOperator::include_mean
protected

Flag indicating whether to include mean term.

Definition at line 183 of file Stokhos_KLMatrixFreeOperator.hpp.

bool Stokhos::KLMatrixFreeOperator::useTranspose
protected

Flag indicating whether transpose was selected.

Definition at line 186 of file Stokhos_KLMatrixFreeOperator.hpp.

int Stokhos::KLMatrixFreeOperator::expansion_size
protected

Number of terms in expansion.

Definition at line 189 of file Stokhos_KLMatrixFreeOperator.hpp.

int Stokhos::KLMatrixFreeOperator::num_blocks
protected

Number of Jacobian blocks (not necessarily equal to expansion_size)

Definition at line 192 of file Stokhos_KLMatrixFreeOperator.hpp.

int Stokhos::KLMatrixFreeOperator::max_num_mat_vec
protected

Maximum number of matvecs in Apply.

Definition at line 195 of file Stokhos_KLMatrixFreeOperator.hpp.

Teuchos::RCP<Epetra_MultiVector> Stokhos::KLMatrixFreeOperator::input_col
mutableprotected

Temporary to store result of importing input into column map.

Definition at line 198 of file Stokhos_KLMatrixFreeOperator.hpp.

Teuchos::RCP<Epetra_MultiVector> Stokhos::KLMatrixFreeOperator::input_col_trans
mutableprotected

Temporary to store result of importing input into column map (transpose)

Definition at line 201 of file Stokhos_KLMatrixFreeOperator.hpp.

Teuchos::Array< Teuchos::RCP<const Epetra_MultiVector> > Stokhos::KLMatrixFreeOperator::input_block
mutableprotected

MultiVectors for each block for Apply() input.

Definition at line 204 of file Stokhos_KLMatrixFreeOperator.hpp.

Teuchos::Array< Teuchos::RCP<Epetra_MultiVector> > Stokhos::KLMatrixFreeOperator::result_block
mutableprotected

MultiVectors for each block for Apply() result.

Definition at line 207 of file Stokhos_KLMatrixFreeOperator.hpp.

Teuchos::RCP<Epetra_MultiVector> Stokhos::KLMatrixFreeOperator::tmp
mutableprotected

Temporary multivector used in Apply()

Definition at line 210 of file Stokhos_KLMatrixFreeOperator.hpp.

Teuchos::RCP<Epetra_MultiVector> Stokhos::KLMatrixFreeOperator::tmp_trans
mutableprotected

Temporary multivector used in Apply() for transpose.

Definition at line 213 of file Stokhos_KLMatrixFreeOperator.hpp.

Cijk_type::k_iterator Stokhos::KLMatrixFreeOperator::k_begin
protected

Starting k iterator.

Definition at line 216 of file Stokhos_KLMatrixFreeOperator.hpp.

Cijk_type::k_iterator Stokhos::KLMatrixFreeOperator::k_end
protected

Ending k iterator.

Definition at line 219 of file Stokhos_KLMatrixFreeOperator.hpp.


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