44#ifndef STOKHOS_DIAG_EPETRA_OP_HPP
45#define STOKHOS_DIAG_EPETRA_OP_HPP
47#include "Teuchos_RCP.hpp"
48#include "Teuchos_Array.hpp"
49#include "Teuchos_Time.hpp"
72 const Teuchos::RCP<const Epetra_Map>& domain_base_map_,
73 const Teuchos::RCP<const Epetra_Map>& range_base_map_,
74 const Teuchos::RCP<const Epetra_Map>& domain_sg_map_,
75 const Teuchos::RCP<const Epetra_Map>& range_sg_map_,
78 const Teuchos::RCP<Stokhos::EpetraOperatorOrthogPoly >& ops);
85 reset(
const Teuchos::RCP<Stokhos::EpetraOperatorOrthogPoly >& ops);
88 virtual Teuchos::RCP<const Stokhos::EpetraOperatorOrthogPoly >
92 virtual Teuchos::RCP< Stokhos::EpetraOperatorOrthogPoly >
102 virtual int Apply(std::vector< Teuchos::RCP< const Epetra_CrsMatrix> >& sg_J_all, std::vector< Teuchos::RCP< Epetra_CrsMatrix> >& sg_Kkk_all)
const;
112 virtual double NormInf()
const;
115 virtual const char*
Label ()
const;
148 return this->
ApplyTimer->totalElapsedTime(
false);};
176 Teuchos::RCP<const Stokhos::OrthogPolyBasis<int,double> >
sg_basis;
179 Teuchos::RCP<const Stokhos::Sparse3Tensor<int,double> >
Cijk;
182 Teuchos::RCP<Stokhos::EpetraOperatorOrthogPoly >
block_ops;
194 mutable Teuchos::Array< Teuchos::RCP<const Epetra_MultiVector> >
input_block;
197 mutable Teuchos::Array< Teuchos::RCP<Epetra_MultiVector> >
result_block;
200 mutable Teuchos::RCP<Epetra_MultiVector>
tmp;
An Epetra operator representing the block stochastic Galerkin operator.
Teuchos::RCP< Epetra_MultiVector > tmp
Temporary multivector used in Apply()
virtual void reset(const Teuchos::RCP< Stokhos::EpetraOperatorOrthogPoly > &ops)
Reset operator blocks.
virtual bool UseTranspose() const
Returns the current UseTranspose setting.
Teuchos::RCP< Epetra_MultiVector > tmp_trans
Temporary multivector used in Apply() for transpose.
virtual Teuchos::RCP< const Stokhos::EpetraOperatorOrthogPoly > getOperatorBlocks() const
Get operator blocks.
Teuchos::Array< Teuchos::RCP< Epetra_MultiVector > > result_block
MultiVectors for each block for Apply() result.
Teuchos::RCP< const Epetra_Map > range_base_map
Stores range base map.
DiagEpetraOp(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< const Stokhos::OrthogPolyBasis< int, double > > &sg_basis, const Teuchos::RCP< const Stokhos::Sparse3Tensor< int, double > > &Cijk, const Teuchos::RCP< Stokhos::EpetraOperatorOrthogPoly > &ops)
Constructor.
Teuchos::RCP< Stokhos::EpetraOperatorOrthogPoly > block_ops
Stores operators.
int expansion_size
Number of terms in expansion.
std::string label
Label for operator.
Teuchos::RCP< const Stokhos::OrthogPolyBasis< int, double > > sg_basis
Stochastic Galerking basis.
virtual int SetUseTranspose(bool UseTranspose)
Set to true if the transpose of the operator is requested.
virtual const Epetra_Map & OperatorRangeMap() const
Returns the Epetra_Map object associated with the range of this matrix operator.
virtual const char * Label() const
Returns a character string describing the operator.
Teuchos::RCP< Teuchos::Time > ApplyTimer
Operation Timer.
int num_blocks
Number of Jacobian blocks (not necessarily equal to expansion_size)
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 ...
virtual ~DiagEpetraOp()
Destructor.
virtual double NormInf() const
Returns an approximate infinity norm of the operator matrix.
Teuchos::RCP< const Epetra_Map > domain_base_map
Stores domain base map.
DiagEpetraOp & operator=(const DiagEpetraOp &)
Private to prohibit copying.
virtual int Apply(std::vector< Teuchos::RCP< const Epetra_CrsMatrix > > &sg_J_all, std::vector< Teuchos::RCP< Epetra_CrsMatrix > > &sg_Kkk_all) const
Returns Diagonal blocks of SG matrix when PC coefficients of the SG matrix are given.
virtual const Epetra_Comm & Comm() const
Returns a reference to the Epetra_Comm communicator associated with this operator.
Teuchos::RCP< const Epetra_Map > domain_sg_map
Stores domain SG map.
virtual const double ApplyTime() const
Returns the time spent applying this operator.
Teuchos::Array< Teuchos::RCP< const Epetra_MultiVector > > input_block
MultiVectors for each block for Apply() input.
DiagEpetraOp(const DiagEpetraOp &)
Private to prohibit copying.
virtual bool HasNormInf() const
Returns true if the this object can provide an approximate Inf-norm, false otherwise.
bool useTranspose
Flag indicating whether transpose was selected.
Teuchos::RCP< const Epetra_Map > range_sg_map
Stores range SG map.
virtual const Epetra_Map & OperatorDomainMap() const
Returns the Epetra_Map object associated with the domain of this matrix operator.
Teuchos::RCP< const Stokhos::Sparse3Tensor< int, double > > Cijk
Stores triple product tensor.
Abstract base class for multivariate orthogonal polynomials.
Data structure storing a sparse 3-tensor C(i,j,k) in a a compressed format.
Top-level namespace for Stokhos classes and functions.