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_KokkosArrayKernelsUnitTest.hpp File Reference
#include "Teuchos_TestingHelpers.hpp"
#include "Teuchos_UnitTestHelpers.hpp"
#include "Teuchos_TestForException.hpp"
#include "Stokhos_Epetra.hpp"
#include "Stokhos_Sparse3TensorUtilities.hpp"
#include "EpetraExt_BlockUtility.h"
#include "Stokhos_UnitTestHelpers.hpp"
#include "Epetra_SerialComm.h"
#include "Kokkos_Macros.hpp"
#include "Stokhos_Update.hpp"
#include "Stokhos_CrsMatrix.hpp"
#include "Stokhos_BlockCrsMatrix.hpp"
#include "Stokhos_StochasticProductTensor.hpp"
#include "Stokhos_CrsProductTensor.hpp"
#include "Stokhos_TiledCrsProductTensor.hpp"
#include "Stokhos_SimpleTiledCrsProductTensor.hpp"
#include "Stokhos_CooProductTensor.hpp"
#include "Stokhos_SymmetricDiagonalSpec.hpp"
#include "Stokhos_FlatSparse3Tensor.hpp"
#include "Stokhos_FlatSparse3Tensor_kji.hpp"
#include "Stokhos_LinearSparse3Tensor.hpp"
#include "Stokhos_LexicographicBlockSparse3Tensor.hpp"
Include dependency graph for Stokhos_KokkosArrayKernelsUnitTest.hpp:
This graph shows which files directly or indirectly include this file:

Go to the source code of this file.

Classes

struct  KokkosKernelsUnitTest::UnitTestSetup< Device >
 

Namespaces

 KokkosKernelsUnitTest
 

Functions

template<typename IntType >
IntType KokkosKernelsUnitTest::map_fem_graph_coord (const IntType &N, const IntType &i, const IntType &j, const IntType &k)
 
template<typename ordinal >
ordinal KokkosKernelsUnitTest::generate_fem_graph (ordinal N, std::vector< std::vector< ordinal > > &graph)
 
template<typename scalar , typename ordinal >
scalar KokkosKernelsUnitTest::generate_matrix_coefficient (const ordinal nFEM, const ordinal nStoch, const ordinal iRowFEM, const ordinal iColFEM, const ordinal iStoch)
 
template<typename scalar , typename ordinal >
scalar KokkosKernelsUnitTest::generate_vector_coefficient (const ordinal nFEM, const ordinal nStoch, const ordinal iColFEM, const ordinal iStoch)
 
template<typename value_type , typename Device , typename SparseMatOps >
bool KokkosKernelsUnitTest::test_crs_matrix_free (const UnitTestSetup< Device > &setup, Teuchos::FancyOStream &out)
 
template<typename value_type , typename Device , typename SparseMatOps >
bool KokkosKernelsUnitTest::test_crs_matrix_free_view (const UnitTestSetup< Device > &setup, Teuchos::FancyOStream &out)
 
template<typename ScalarType , class Device >
bool KokkosKernelsUnitTest::test_crs_dense_block (const UnitTestSetup< Device > &setup, Teuchos::FancyOStream &out)
 
template<typename ScalarType , class Device >
bool KokkosKernelsUnitTest::test_crs_flat_commuted (const UnitTestSetup< Device > &setup, Teuchos::FancyOStream &out)
 
template<typename ScalarType , class Device >
bool KokkosKernelsUnitTest::test_crs_flat_original (const UnitTestSetup< Device > &setup, Teuchos::FancyOStream &out)
 
template<typename ScalarType , typename TensorType , class Device >
bool KokkosKernelsUnitTest::test_crs_product_tensor (const UnitTestSetup< Device > &setup, Teuchos::FancyOStream &out, const Teuchos::ParameterList &params=Teuchos::ParameterList())
 
template<typename ScalarType , class Device , int BlockSize>
bool KokkosKernelsUnitTest::test_linear_tensor (const UnitTestSetup< Device > &setup, Teuchos::FancyOStream &out, const bool symmetric)
 
template<typename ScalarType , class Device >
bool KokkosKernelsUnitTest::test_lexo_block_tensor (const UnitTestSetup< Device > &setup, Teuchos::FancyOStream &out)