|
Stokhos Package Browser (Single Doxygen Collection)
Version of the Day
|
Classes | |
| struct | performance_test_driver< Scalar, Kokkos::Cuda > |
| struct | performance_test_driver |
| struct | ScalarTolerances |
| struct | ScalarTolerances< float > |
| struct | ScalarTolerances< double > |
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< double > | test_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< double > | test_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< double > | test_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< double > | test_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< double > | test_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< double > | test_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< double > | test_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< double > | test_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< double > | test_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< double > | test_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) |
|
inline |
Definition at line 54 of file TestStochastic.hpp.
|
inline |
Definition at line 63 of file TestStochastic.hpp.
| 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 109 of file TestStochastic.hpp.
| 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 218 of file TestStochastic.hpp.
| 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 322 of file TestStochastic.hpp.
| 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 479 of file TestStochastic.hpp.
| 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 627 of file TestStochastic.hpp.
| 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 738 of file TestStochastic.hpp.
| 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 848 of file TestStochastic.hpp.
| 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 953 of file TestStochastic.hpp.
| 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 1061 of file TestStochastic.hpp.
| 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 1200 of file TestStochastic.hpp.
| 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 1496 of file TestStochastic.hpp.
| 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 1594 of file TestStochastic.hpp.
| 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 1689 of file TestStochastic.hpp.
| 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 1769 of file TestStochastic.hpp.
1.8.5