Stokhos Package Browser (Single Doxygen Collection)  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Classes | Namespaces | Functions
Stokhos_Tpetra_Utilities.hpp File Reference
#include "Stokhos_Tpetra_UQ_PCE.hpp"
#include "Stokhos_Tpetra_MP_Vector.hpp"
#include "Tpetra_CrsMatrix.hpp"
Include dependency graph for Stokhos_Tpetra_Utilities.hpp:
This graph shows which files directly or indirectly include this file:

Go to the source code of this file.

Classes

class  Stokhos::GetMeanValsFunc< ViewType >
 Get mean values matrix for mean-based preconditioning. More...
 
class  Stokhos::GetMeanValsFunc< Kokkos::View< Sacado::UQ::PCE< Storage > *, P... > >
 Get mean values matrix for mean-based preconditioning. More...
 
class  Stokhos::GetMeanValsFunc< Kokkos::View< Sacado::MP::Vector< Storage > *, P... > >
 Get mean values matrix for mean-based preconditioning. More...
 
class  Stokhos::GetScalarMeanValsFunc< ViewType >
 Get mean values matrix for mean-based preconditioning. More...
 
class  Stokhos::GetScalarMeanValsFunc< Kokkos::View< Sacado::UQ::PCE< Storage > *, P... > >
 Get mean values matrix for mean-based preconditioning. More...
 
class  Stokhos::GetScalarMeanValsFunc< Kokkos::View< Sacado::MP::Vector< Storage > *, P... > >
 Get mean values matrix for mean-based preconditioning. More...
 
struct  Stokhos::Impl::CopyPCE2Scalar< ExecSpace >
 
struct  Stokhos::Impl::CopyScalar2PCE< ExecSpace >
 
class  Stokhos::MeanBasedTpetraOperator< Scalar, LocalOrdinal, GlobalOrdinal, Node >
 

Namespaces

 Stokhos
 Top-level namespace for Stokhos classes and functions.
 
 Stokhos::Impl
 

Functions

template<typename Scalar , typename LO , typename GO , typename N >
Teuchos::RCP
< Tpetra::CrsMatrix< Scalar,
LO, GO, N > > 
Stokhos::build_mean_matrix (const Tpetra::CrsMatrix< Scalar, LO, GO, N > &A)
 
template<typename Scalar , typename LO , typename GO , typename N >
Teuchos::RCP
< Tpetra::CrsMatrix< typename
Scalar::value_type, LO, GO, N > > 
Stokhos::build_mean_scalar_matrix (const Tpetra::CrsMatrix< Scalar, LO, GO, N > &A)
 
template<typename DstView , typename SrcView >
void Stokhos::copy_pce_to_scalar (const DstView &dst, const SrcView &src)
 
template<typename DstView , typename SrcView >
void Stokhos::copy_scalar_to_pce (const DstView &dst, const SrcView &src)