Stokhos Package Browser (Single Doxygen Collection)  Version of the Day
Classes | Functions
unit_test Namespace Reference

Classes

struct  performance_test_driver
 
struct  performance_test_driver< Scalar, Kokkos::Cuda >
 
struct  ScalarTolerances
 
struct  ScalarTolerances< double >
 
struct  ScalarTolerances< float >
 

Functions

template<typename IntType >
IntType map_fem_graph_coord (const IntType &N, const IntType &i, const IntType &j, const IntType &k)
 
size_t generate_fem_graph (size_t N, std::vector< std::vector< size_t > > &graph)
 
template<typename ScalarType , typename TensorType , class Device >
std::vector< doubletest_product_tensor_matrix (const std::vector< int > &var_degree, const int nGrid, const int iterCount, const bool symmetric)
 
template<typename ScalarType , class Device >
std::vector< doubletest_product_tensor_diagonal_matrix (const std::vector< int > &var_degree, const int nGrid, const int iterCount, const bool symmetric)
 
template<typename ScalarType , class Device >
std::vector< doubletest_product_flat_commuted_matrix (const std::vector< int > &var_degree, const int nGrid, const int iterCount, const bool symmetric)
 
template<typename ScalarType , class Device >
std::vector< doubletest_product_flat_original_matrix (const std::vector< int > &var_degree, const int nGrid, const int iterCount, const bool symmetric)
 
template<typename ScalarType , class Device >
std::vector< doubletest_tiled_product_tensor_matrix (const std::vector< int > &var_degree, const int nGrid, const int iterCount, const bool symmetric)
 
template<typename ScalarType , class Device >
std::vector< doubletest_simple_tiled_product_tensor_matrix (const std::vector< int > &var_degree, const int nGrid, const int iterCount, const bool symmetric)
 
template<typename ScalarType , class Device >
std::vector< doubletest_lexo_block_tensor (const std::vector< int > &var_degree, const int nGrid, const int iterCount, const bool symmetric)
 
template<typename ScalarType , class Device >
std::vector< doubletest_linear_tensor (const std::vector< int > &var_degree, const int nGrid, const int iterCount, const bool symmetric)
 
template<typename ScalarType , class Device , class SparseMatOps >
std::vector< doubletest_original_matrix_free_vec (const std::vector< int > &var_degree, const int nGrid, const int iterCount, const bool test_block, const bool symmetric)
 
template<typename ScalarType , class Device , class SparseMatOps >
std::vector< doubletest_original_matrix_free_view (const std::vector< int > &var_degree, const int nGrid, const int iterCount, const bool test_block, const bool symmetric)
 
template<class Scalar , class Device >
void performance_test_driver_all (const int pdeg, const int minvar, const int maxvar, const int nGrid, const int nIter, const bool test_block, const bool symmetric)
 
template<class Scalar , class Device , class SparseMatOps >
void performance_test_driver_poly (const int pdeg, const int minvar, const int maxvar, const int nGrid, const int nIter, const bool test_block, const bool symmetric)
 
template<class Scalar , class Device , class SparseMatOps >
void performance_test_driver_poly_deg (const int nvar, const int minp, const int maxp, const int nGrid, const int nIter, const bool test_block, const bool symmetric)
 
template<class Scalar , class Device , class SparseMatOps >
void performance_test_driver_linear (const int minvar, const int maxvar, const int varinc, const int nGrid, const int nIter, const bool test_block, const bool symmetric)
 

Function Documentation

◆ map_fem_graph_coord()

template<typename IntType >
IntType unit_test::map_fem_graph_coord ( const IntType &  N,
const IntType &  i,
const IntType &  j,
const IntType &  k 
)
inline

Definition at line 84 of file TestStochastic.hpp.

◆ generate_fem_graph()

size_t unit_test::generate_fem_graph ( size_t  N,
std::vector< std::vector< size_t > > &  graph 
)
inline

Definition at line 93 of file TestStochastic.hpp.

◆ test_product_tensor_matrix()

template<typename ScalarType , typename TensorType , class Device >
std::vector<double> unit_test::test_product_tensor_matrix ( const std::vector< int > &  var_degree,
const int  nGrid,
const int  iterCount,
const bool  symmetric 
)

Definition at line 139 of file TestStochastic.hpp.

◆ test_product_tensor_diagonal_matrix()

template<typename ScalarType , class Device >
std::vector<double> unit_test::test_product_tensor_diagonal_matrix ( const std::vector< int > &  var_degree,
const int  nGrid,
const int  iterCount,
const bool  symmetric 
)

Definition at line 248 of file TestStochastic.hpp.

◆ test_product_flat_commuted_matrix()

template<typename ScalarType , class Device >
std::vector<double> unit_test::test_product_flat_commuted_matrix ( const std::vector< int > &  var_degree,
const int  nGrid,
const int  iterCount,
const bool  symmetric 
)

Definition at line 352 of file TestStochastic.hpp.

◆ test_product_flat_original_matrix()

template<typename ScalarType , class Device >
std::vector<double> unit_test::test_product_flat_original_matrix ( const std::vector< int > &  var_degree,
const int  nGrid,
const int  iterCount,
const bool  symmetric 
)

Definition at line 509 of file TestStochastic.hpp.

◆ test_tiled_product_tensor_matrix()

template<typename ScalarType , class Device >
std::vector<double> unit_test::test_tiled_product_tensor_matrix ( const std::vector< int > &  var_degree,
const int  nGrid,
const int  iterCount,
const bool  symmetric 
)

Definition at line 657 of file TestStochastic.hpp.

◆ test_simple_tiled_product_tensor_matrix()

template<typename ScalarType , class Device >
std::vector<double> unit_test::test_simple_tiled_product_tensor_matrix ( const std::vector< int > &  var_degree,
const int  nGrid,
const int  iterCount,
const bool  symmetric 
)

Definition at line 768 of file TestStochastic.hpp.

◆ test_lexo_block_tensor()

template<typename ScalarType , class Device >
std::vector<double> unit_test::test_lexo_block_tensor ( const std::vector< int > &  var_degree,
const int  nGrid,
const int  iterCount,
const bool  symmetric 
)

Definition at line 878 of file TestStochastic.hpp.

◆ test_linear_tensor()

template<typename ScalarType , class Device >
std::vector<double> unit_test::test_linear_tensor ( const std::vector< int > &  var_degree,
const int  nGrid,
const int  iterCount,
const bool  symmetric 
)

Definition at line 983 of file TestStochastic.hpp.

◆ test_original_matrix_free_vec()

template<typename ScalarType , class Device , class SparseMatOps >
std::vector<double> unit_test::test_original_matrix_free_vec ( const std::vector< int > &  var_degree,
const int  nGrid,
const int  iterCount,
const bool  test_block,
const bool  symmetric 
)

Definition at line 1091 of file TestStochastic.hpp.

◆ test_original_matrix_free_view()

template<typename ScalarType , class Device , class SparseMatOps >
std::vector<double> unit_test::test_original_matrix_free_view ( const std::vector< int > &  var_degree,
const int  nGrid,
const int  iterCount,
const bool  test_block,
const bool  symmetric 
)

Definition at line 1230 of file TestStochastic.hpp.

◆ performance_test_driver_all()

template<class Scalar , class Device >
void unit_test::performance_test_driver_all ( const int  pdeg,
const int  minvar,
const int  maxvar,
const int  nGrid,
const int  nIter,
const bool  test_block,
const bool  symmetric 
)

Definition at line 1526 of file TestStochastic.hpp.

◆ performance_test_driver_poly()

template<class Scalar , class Device , class SparseMatOps >
void unit_test::performance_test_driver_poly ( const int  pdeg,
const int  minvar,
const int  maxvar,
const int  nGrid,
const int  nIter,
const bool  test_block,
const bool  symmetric 
)

Definition at line 1624 of file TestStochastic.hpp.

◆ performance_test_driver_poly_deg()

template<class Scalar , class Device , class SparseMatOps >
void unit_test::performance_test_driver_poly_deg ( const int  nvar,
const int  minp,
const int  maxp,
const int  nGrid,
const int  nIter,
const bool  test_block,
const bool  symmetric 
)

Definition at line 1719 of file TestStochastic.hpp.

◆ performance_test_driver_linear()

template<class Scalar , class Device , class SparseMatOps >
void unit_test::performance_test_driver_linear ( const int  minvar,
const int  maxvar,
const int  varinc,
const int  nGrid,
const int  nIter,
const bool  test_block,
const bool  symmetric 
)

Definition at line 1799 of file TestStochastic.hpp.