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

Go to the source code of this file.

Classes

struct  PerformanceDriverOp< Storage, Method >
 

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 StorageType , typename MultiplyTag >
std::vector< doubletest_mpvector_spmv (const int ensemble_length, const int nGrid, const int iterCount, KokkosSparse::DeviceConfig dev_config, MultiplyTag tag)
 
template<typename ScalarType , typename OrdinalType , typename Device >
std::vector< doubletest_scalar_spmv (const int ensemble_length, const int nGrid, const int iterCount, KokkosSparse::DeviceConfig dev_config)
 
template<class Storage , int entry_min, int entry_max, int entry_step>
void performance_test_driver (const int nGrid, const int nIter, KokkosSparse::DeviceConfig dev_config)
 

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 28 of file TestSpMv.hpp.

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

Definition at line 37 of file TestSpMv.hpp.

template<typename StorageType , typename MultiplyTag >
std::vector<double> test_mpvector_spmv ( const int  ensemble_length,
const int  nGrid,
const int  iterCount,
KokkosSparse::DeviceConfig  dev_config,
MultiplyTag  tag 
)

Definition at line 71 of file TestSpMv.hpp.

template<typename ScalarType , typename OrdinalType , typename Device >
std::vector<double> test_scalar_spmv ( const int  ensemble_length,
const int  nGrid,
const int  iterCount,
KokkosSparse::DeviceConfig  dev_config 
)

Definition at line 156 of file TestSpMv.hpp.

template<class Storage , int entry_min, int entry_max, int entry_step>
void performance_test_driver ( const int  nGrid,
const int  nIter,
KokkosSparse::DeviceConfig  dev_config 
)

Definition at line 274 of file TestSpMv.hpp.