Stokhos Package Browser (Single Doxygen Collection)  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Macros | Functions
TestMeanMultiply.hpp File Reference
#include <iostream>
#include "Stokhos_Sacado_Kokkos_UQ_PCE.hpp"
#include "KokkosSparse_CrsMatrix.hpp"
#include "KokkosSparse_spmv.hpp"
#include "Kokkos_CrsMatrix_UQ_PCE.hpp"
#include "Kokkos_CrsMatrix_UQ_PCE_Cuda.hpp"
#include "Stokhos_LegendreBasis.hpp"
#include "Stokhos_TotalOrderBasis.hpp"
#include "Stokhos_Sparse3Tensor.hpp"
#include "Kokkos_Timer.hpp"
Include dependency graph for TestMeanMultiply.hpp:
This graph shows which files directly or indirectly include this file:

Go to the source code of this file.

Macros

#define INST_PERF_DRIVER(SCALAR, ORDINAL, DEVICE)
 

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 OrdinalType , typename Device >
void test_mean_multiply (const OrdinalType order, const OrdinalType dim, const OrdinalType nGrid, const OrdinalType iterCount, std::vector< double > &scalar_perf, std::vector< double > &block_left_perf, std::vector< double > &block_right_perf, std::vector< double > &pce_perf, std::vector< double > &block_pce_perf)
 
template<typename Scalar , typename Ordinal , typename Device >
void performance_test_driver (const Ordinal nGrid, const Ordinal nIter, const Ordinal order, const Ordinal min_var, const Ordinal max_var)
 

Macro Definition Documentation

#define INST_PERF_DRIVER (   SCALAR,
  ORDINAL,
  DEVICE 
)
Value:
template void performance_test_driver< SCALAR, ORDINAL, DEVICE >( \
const ORDINAL nGrid, const ORDINAL nIter, const ORDINAL order, \
const ORDINAL min_var, const ORDINAL max_var);

Definition at line 401 of file TestMeanMultiply.hpp.

Function Documentation

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

Definition at line 31 of file TestMeanMultiply.hpp.

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

Definition at line 40 of file TestMeanMultiply.hpp.

template<typename ScalarType , typename OrdinalType , typename Device >
void test_mean_multiply ( const OrdinalType  order,
const OrdinalType  dim,
const OrdinalType  nGrid,
const OrdinalType  iterCount,
std::vector< double > &  scalar_perf,
std::vector< double > &  block_left_perf,
std::vector< double > &  block_right_perf,
std::vector< double > &  pce_perf,
std::vector< double > &  block_pce_perf 
)

Definition at line 74 of file TestMeanMultiply.hpp.

template<typename Scalar , typename Ordinal , typename Device >
void performance_test_driver ( const Ordinal  nGrid,
const Ordinal  nIter,
const Ordinal  order,
const Ordinal  min_var,
const Ordinal  max_var 
)

Definition at line 344 of file TestMeanMultiply.hpp.