Stokhos Package Browser (Single Doxygen Collection)  Version of the Day
Public Types | Public Member Functions | Protected Member Functions | Protected Attributes | List of all members
Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type > Class Template Reference

An operator for building pseudo-spectral coefficients using a sparse Smolyak construction. More...

#include <Stokhos_SmolyakPseudoSpectralOperator.hpp>

Inheritance diagram for Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >:
Inheritance graph
[legend]

Public Types

typedef ordinal_t ordinal_type
 
typedef value_t value_type
 
typedef PseudoSpectralOperator< ordinal_type, value_type, point_compare_type > base_type
 
typedef base_type::point_type point_type
 
typedef base_type::point_set_type point_set_type
 
typedef base_type::point_map_type point_map_type
 
typedef base_type::iterator iterator
 
typedef base_type::const_iterator const_iterator
 
typedef base_type::set_iterator set_iterator
 
typedef base_type::const_set_iterator const_set_iterator
 
typedef MultiIndex< ordinal_typemultiindex_type
 
typedef TensorProductPseudoSpectralOperator< ordinal_type, value_typeoperator_type
 
typedef Teuchos::Array< Teuchos::RCP< operator_type > > operator_set_type
 
- Public Types inherited from Stokhos::PseudoSpectralOperator< ordinal_t, value_t, point_compare_type >
typedef ordinal_t ordinal_type
 
typedef value_t value_type
 
typedef TensorProductElement< ordinal_type, value_typepoint_type
 
typedef std::map< point_type, std::pair< value_type, ordinal_type >, point_compare_type > point_set_type
 
typedef Teuchos::Array< point_typepoint_map_type
 
typedef point_map_type::iterator iterator
 
typedef point_map_type::const_iterator const_iterator
 
typedef point_set_type::iterator set_iterator
 
typedef point_set_type::const_iterator const_set_iterator
 

Public Member Functions

template<typename coeff_compare_type >
 SmolyakPseudoSpectralOperator (const SmolyakBasis< ordinal_type, value_type, coeff_compare_type > &smolyak_basis, bool use_smolyak_apply=true, bool use_pst=true, const point_compare_type &point_compare=point_compare_type())
 Constructor. More...
 
virtual ~SmolyakPseudoSpectralOperator ()
 Destructor. More...
 
ordinal_type point_size () const
 Number of points. More...
 
ordinal_type coeff_size () const
 Number of coefficients. More...
 
iterator begin ()
 Iterator to begining of point set. More...
 
iterator end ()
 Iterator to end of point set. More...
 
const_iterator begin () const
 Iterator to begining of point set. More...
 
const_iterator end () const
 Iterator to end of point set. More...
 
set_iterator set_begin ()
 Iterator to begining of point set. More...
 
set_iterator set_end ()
 Iterator to end of point set. More...
 
const_set_iterator set_begin () const
 Iterator to begining of point set. More...
 
const_set_iterator set_end () const
 Iterator to end of point set. More...
 
ordinal_type index (const point_type &point) const
 Get point index for given point. More...
 
const point_typepoint (ordinal_type n) const
 Get point for given index. More...
 
void transformQP2PCE (const value_type &alpha, const Teuchos::SerialDenseMatrix< ordinal_type, value_type > &input, Teuchos::SerialDenseMatrix< ordinal_type, value_type > &result, const value_type &beta, bool trans=false) const
 Transform values at quadrature points to PCE coefficients. More...
 
virtual void transformPCE2QP (const value_type &alpha, const Teuchos::SerialDenseMatrix< ordinal_type, value_type > &input, Teuchos::SerialDenseMatrix< ordinal_type, value_type > &result, const value_type &beta, bool trans=false) const
 Transform PCE coefficients to quadrature values. More...
 
- Public Member Functions inherited from Stokhos::PseudoSpectralOperator< ordinal_t, value_t, point_compare_type >
 PseudoSpectralOperator ()
 Constructor. More...
 
virtual ~PseudoSpectralOperator ()
 Destructor. More...
 

Protected Member Functions

void apply_direct (const Teuchos::SerialDenseMatrix< ordinal_type, value_type > &A, const value_type &alpha, const Teuchos::SerialDenseMatrix< ordinal_type, value_type > &input, Teuchos::SerialDenseMatrix< ordinal_type, value_type > &result, const value_type &beta, bool trans) const
 Apply transformation operator using direct method. More...
 
void transformQP2PCE_smolyak (const value_type &alpha, const Teuchos::SerialDenseMatrix< ordinal_type, value_type > &input, Teuchos::SerialDenseMatrix< ordinal_type, value_type > &result, const value_type &beta, bool trans) const
 Transform values at quadrature points to PCE coefficients using Smolyak formula. More...
 
void transformPCE2QP_smolyak (const value_type &alpha, const Teuchos::SerialDenseMatrix< ordinal_type, value_type > &input, Teuchos::SerialDenseMatrix< ordinal_type, value_type > &result, const value_type &beta, bool trans) const
 Transform PCE coefficients to values at quadrature points using Smolyak formula. More...
 
void gather (const Teuchos::Array< ordinal_type > &map, const Teuchos::SerialDenseMatrix< ordinal_type, value_type > &input, bool trans, Teuchos::SerialDenseMatrix< ordinal_type, value_type > &result) const
 
void scatter (const Teuchos::Array< ordinal_type > &map, const Teuchos::SerialDenseMatrix< ordinal_type, value_type > &input, bool trans, Teuchos::SerialDenseMatrix< ordinal_type, value_type > &result) const
 

Protected Attributes

bool use_smolyak
 Use Smolyak apply method. More...
 
ordinal_type coeff_sz
 Number of coefficients. More...
 
point_set_type points
 Smolyak sparse grid. More...
 
point_map_type point_map
 Map index to sparse grid term. More...
 
Teuchos::Array< value_typesmolyak_coeffs
 Smolyak coefficients. More...
 
operator_set_type operators
 Tensor pseudospectral operators. More...
 
Teuchos::Array< Teuchos::Array< ordinal_type > > gather_maps
 Gather maps for each operator for Smolyak apply. More...
 
Teuchos::Array< Teuchos::Array< ordinal_type > > scatter_maps
 Scatter maps for each operator for Smolyak apply. More...
 
Teuchos::SerialDenseMatrix< ordinal_type, value_typeqp2pce
 Matrix mapping points to coefficients. More...
 
Teuchos::SerialDenseMatrix< ordinal_type, value_typepce2qp
 Matrix mapping coefficients to points. More...
 
Teuchos::BLAS< ordinal_type, value_typeblas
 BLAS wrappers. More...
 

Detailed Description

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
class Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >

An operator for building pseudo-spectral coefficients using a sparse Smolyak construction.

Definition at line 61 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

Member Typedef Documentation

◆ ordinal_type

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
typedef ordinal_t Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::ordinal_type

Definition at line 65 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ value_type

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
typedef value_t Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::value_type

Definition at line 66 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ base_type

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
typedef PseudoSpectralOperator<ordinal_type,value_type,point_compare_type> Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::base_type

Definition at line 67 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ point_type

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
typedef base_type::point_type Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::point_type

Definition at line 68 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ point_set_type

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
typedef base_type::point_set_type Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::point_set_type

Definition at line 69 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ point_map_type

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
typedef base_type::point_map_type Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::point_map_type

Definition at line 70 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ iterator

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
typedef base_type::iterator Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::iterator

Definition at line 71 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ const_iterator

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
typedef base_type::const_iterator Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::const_iterator

Definition at line 72 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ set_iterator

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
typedef base_type::set_iterator Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::set_iterator

Definition at line 73 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ const_set_iterator

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
typedef base_type::const_set_iterator Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::const_set_iterator

Definition at line 74 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ multiindex_type

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
typedef MultiIndex<ordinal_type> Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::multiindex_type

Definition at line 76 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ operator_type

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
typedef TensorProductPseudoSpectralOperator<ordinal_type, value_type> Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::operator_type

Definition at line 77 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ operator_set_type

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
typedef Teuchos::Array< Teuchos::RCP<operator_type> > Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::operator_set_type

Definition at line 78 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

Constructor & Destructor Documentation

◆ SmolyakPseudoSpectralOperator()

template<typename ordinal_type , typename value_type , typename point_compare_type >
template<typename coeff_compare_type >
Stokhos::SmolyakPseudoSpectralOperator< ordinal_type, value_type, point_compare_type >::SmolyakPseudoSpectralOperator ( const SmolyakBasis< ordinal_type, value_type, coeff_compare_type > &  smolyak_basis,
bool  use_smolyak_apply = true,
bool  use_pst = true,
const point_compare_type &  point_compare = point_compare_type() 
)

Constructor.

Definition at line 45 of file Stokhos_SmolyakPseudoSpectralOperatorImp.hpp.

◆ ~SmolyakPseudoSpectralOperator()

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
virtual Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::~SmolyakPseudoSpectralOperator ( )
inlinevirtual

Destructor.

Definition at line 89 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

Member Function Documentation

◆ point_size()

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
ordinal_type Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::point_size ( ) const
inlinevirtual

◆ coeff_size()

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
ordinal_type Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::coeff_size ( ) const
inlinevirtual

◆ begin() [1/2]

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
iterator Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::begin ( )
inlinevirtual

Iterator to begining of point set.

Implements Stokhos::PseudoSpectralOperator< ordinal_t, value_t, point_compare_type >.

Definition at line 98 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ end() [1/2]

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
iterator Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::end ( )
inlinevirtual

◆ begin() [2/2]

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
const_iterator Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::begin ( ) const
inlinevirtual

Iterator to begining of point set.

Implements Stokhos::PseudoSpectralOperator< ordinal_t, value_t, point_compare_type >.

Definition at line 104 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ end() [2/2]

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
const_iterator Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::end ( ) const
inlinevirtual

◆ set_begin() [1/2]

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
set_iterator Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::set_begin ( )
inlinevirtual

Iterator to begining of point set.

Implements Stokhos::PseudoSpectralOperator< ordinal_t, value_t, point_compare_type >.

Definition at line 110 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ set_end() [1/2]

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
set_iterator Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::set_end ( )
inlinevirtual

◆ set_begin() [2/2]

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
const_set_iterator Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::set_begin ( ) const
inlinevirtual

Iterator to begining of point set.

Implements Stokhos::PseudoSpectralOperator< ordinal_t, value_t, point_compare_type >.

Definition at line 116 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ set_end() [2/2]

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
const_set_iterator Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::set_end ( ) const
inlinevirtual

◆ index()

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
ordinal_type Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::index ( const point_type point) const
inlinevirtual

◆ point()

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
const point_type& Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::point ( ordinal_type  n) const
inlinevirtual

◆ transformQP2PCE()

template<typename ordinal_type , typename value_type , typename point_compare_type >
void Stokhos::SmolyakPseudoSpectralOperator< ordinal_type, value_type, point_compare_type >::transformQP2PCE ( const value_type alpha,
const Teuchos::SerialDenseMatrix< ordinal_type, value_type > &  input,
Teuchos::SerialDenseMatrix< ordinal_type, value_type > &  result,
const value_type beta,
bool  trans = false 
) const
virtual

Transform values at quadrature points to PCE coefficients.

input is a vector storing values of a function at the quadrature points, and result will contain the resulting polynomial chaos coefficients. input and result can have multiple columns for vector-valued functions and set trans to true if these (multi-) vectors are layed out in a transposed fashion.

Implements Stokhos::PseudoSpectralOperator< ordinal_t, value_t, point_compare_type >.

Definition at line 165 of file Stokhos_SmolyakPseudoSpectralOperatorImp.hpp.

◆ transformPCE2QP()

template<typename ordinal_type , typename value_type , typename point_compare_type >
void Stokhos::SmolyakPseudoSpectralOperator< ordinal_type, value_type, point_compare_type >::transformPCE2QP ( const value_type alpha,
const Teuchos::SerialDenseMatrix< ordinal_type, value_type > &  input,
Teuchos::SerialDenseMatrix< ordinal_type, value_type > &  result,
const value_type beta,
bool  trans = false 
) const
virtual

Transform PCE coefficients to quadrature values.

input is a vector storing polynomial chaos coefficients and result will contain the resulting values at the quadrature points. input and result can have multiple columns for vector-valued functions and set trans to true if these (multi-) vectors are layed out in a transposed fashion.

Implements Stokhos::PseudoSpectralOperator< ordinal_t, value_t, point_compare_type >.

Definition at line 182 of file Stokhos_SmolyakPseudoSpectralOperatorImp.hpp.

◆ apply_direct()

template<typename ordinal_type , typename value_type , typename point_compare_type >
void Stokhos::SmolyakPseudoSpectralOperator< ordinal_type, value_type, point_compare_type >::apply_direct ( const Teuchos::SerialDenseMatrix< ordinal_type, value_type > &  A,
const value_type alpha,
const Teuchos::SerialDenseMatrix< ordinal_type, value_type > &  input,
Teuchos::SerialDenseMatrix< ordinal_type, value_type > &  result,
const value_type beta,
bool  trans 
) const
protected

Apply transformation operator using direct method.

Definition at line 204 of file Stokhos_SmolyakPseudoSpectralOperatorImp.hpp.

◆ transformQP2PCE_smolyak()

template<typename ordinal_type , typename value_type , typename point_compare_type >
void Stokhos::SmolyakPseudoSpectralOperator< ordinal_type, value_type, point_compare_type >::transformQP2PCE_smolyak ( const value_type alpha,
const Teuchos::SerialDenseMatrix< ordinal_type, value_type > &  input,
Teuchos::SerialDenseMatrix< ordinal_type, value_type > &  result,
const value_type beta,
bool  trans 
) const
protected

Transform values at quadrature points to PCE coefficients using Smolyak formula.

Definition at line 235 of file Stokhos_SmolyakPseudoSpectralOperatorImp.hpp.

◆ transformPCE2QP_smolyak()

template<typename ordinal_type , typename value_type , typename point_compare_type >
void Stokhos::SmolyakPseudoSpectralOperator< ordinal_type, value_type, point_compare_type >::transformPCE2QP_smolyak ( const value_type alpha,
const Teuchos::SerialDenseMatrix< ordinal_type, value_type > &  input,
Teuchos::SerialDenseMatrix< ordinal_type, value_type > &  result,
const value_type beta,
bool  trans 
) const
protected

Transform PCE coefficients to values at quadrature points using Smolyak formula.

Definition at line 263 of file Stokhos_SmolyakPseudoSpectralOperatorImp.hpp.

◆ gather()

template<typename ordinal_type , typename value_type , typename point_compare_type >
void Stokhos::SmolyakPseudoSpectralOperator< ordinal_type, value_type, point_compare_type >::gather ( const Teuchos::Array< ordinal_type > &  map,
const Teuchos::SerialDenseMatrix< ordinal_type, value_type > &  input,
bool  trans,
Teuchos::SerialDenseMatrix< ordinal_type, value_type > &  result 
) const
protected

◆ scatter()

template<typename ordinal_type , typename value_type , typename point_compare_type >
void Stokhos::SmolyakPseudoSpectralOperator< ordinal_type, value_type, point_compare_type >::scatter ( const Teuchos::Array< ordinal_type > &  map,
const Teuchos::SerialDenseMatrix< ordinal_type, value_type > &  input,
bool  trans,
Teuchos::SerialDenseMatrix< ordinal_type, value_type > &  result 
) const
protected

Member Data Documentation

◆ use_smolyak

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
bool Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::use_smolyak
protected

Use Smolyak apply method.

Definition at line 210 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ coeff_sz

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
ordinal_type Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::coeff_sz
protected

Number of coefficients.

Definition at line 213 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ points

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
point_set_type Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::points
protected

Smolyak sparse grid.

Definition at line 216 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ point_map

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
point_map_type Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::point_map
protected

Map index to sparse grid term.

Definition at line 219 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ smolyak_coeffs

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
Teuchos::Array<value_type> Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::smolyak_coeffs
protected

Smolyak coefficients.

Definition at line 222 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ operators

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
operator_set_type Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::operators
protected

Tensor pseudospectral operators.

Definition at line 225 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ gather_maps

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
Teuchos::Array< Teuchos::Array<ordinal_type> > Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::gather_maps
protected

Gather maps for each operator for Smolyak apply.

Definition at line 228 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ scatter_maps

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
Teuchos::Array< Teuchos::Array<ordinal_type> > Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::scatter_maps
protected

Scatter maps for each operator for Smolyak apply.

Definition at line 231 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ qp2pce

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
Teuchos::SerialDenseMatrix<ordinal_type,value_type> Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::qp2pce
protected

Matrix mapping points to coefficients.

Definition at line 234 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ pce2qp

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
Teuchos::SerialDenseMatrix<ordinal_type,value_type> Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::pce2qp
protected

Matrix mapping coefficients to points.

Definition at line 237 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.

◆ blas

template<typename ordinal_t, typename value_t, typename point_compare_type = typename DefaultPointCompare<ordinal_t,value_t>::type>
Teuchos::BLAS<ordinal_type,value_type> Stokhos::SmolyakPseudoSpectralOperator< ordinal_t, value_t, point_compare_type >::blas
protected

BLAS wrappers.

Definition at line 240 of file Stokhos_SmolyakPseudoSpectralOperator.hpp.


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