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
TestStochastic.hpp File Reference
#include <utility>
#include <cmath>
#include <iostream>
#include "Kokkos_Core.hpp"
#include "Kokkos_Timer.hpp"
#include "Stokhos_Update.hpp"
#include "Stokhos_CrsMatrix.hpp"
#include "Stokhos_BlockCrsMatrix.hpp"
#include "Stokhos_StochasticProductTensor.hpp"
#include "Stokhos_SymmetricDiagonalSpec.hpp"
#include "Stokhos_CrsProductTensor.hpp"
#include "Stokhos_TiledCrsProductTensor.hpp"
#include "Stokhos_SimpleTiledCrsProductTensor.hpp"
#include "Stokhos_CooProductTensor.hpp"
#include "Stokhos_FlatSparse3Tensor.hpp"
#include "Stokhos_FlatSparse3Tensor_kji.hpp"
#include "Stokhos_LexicographicBlockSparse3Tensor.hpp"
#include "Stokhos_LinearSparse3Tensor.hpp"
#include "Epetra_SerialComm.h"
#include "Stokhos_LegendreBasis.hpp"
#include "Stokhos_JacobiBasis.hpp"
#include "Stokhos_CompletePolynomialBasis.hpp"
#include "Stokhos_TotalOrderBasis.hpp"
#include "Stokhos_Sparse3Tensor.hpp"
#include "Stokhos_LTBSparse3Tensor.hpp"
#include "Stokhos_Sparse3TensorUtilities.hpp"
Include dependency graph for TestStochastic.hpp:
This graph shows which files directly or indirectly include this file:

Go to the source code of this file.

Classes

struct  unit_test::ScalarTolerances< Scalar >
 
struct  unit_test::ScalarTolerances< float >
 
struct  unit_test::ScalarTolerances< double >
 
struct  unit_test::performance_test_driver< Scalar, Device >
 

Namespaces

 unit_test
 

Functions

template<typename IntType >
IntType unit_test::map_fem_graph_coord (const IntType &N, const IntType &i, const IntType &j, const IntType &k)
 
size_t unit_test::generate_fem_graph (size_t N, std::vector< std::vector< size_t > > &graph)
 
template<typename ScalarType , typename TensorType , class Device >
std::vector< doubleunit_test::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< doubleunit_test::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< doubleunit_test::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< doubleunit_test::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< doubleunit_test::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< doubleunit_test::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< doubleunit_test::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< doubleunit_test::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< doubleunit_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)
 
template<typename ScalarType , class Device , class SparseMatOps >
std::vector< doubleunit_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)
 
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)
 
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)
 
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)
 
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)