48 #include "KokkosSparse_CrsMatrix.hpp"
49 #include "KokkosSparse_spmv.hpp"
59 #include "impl/Kokkos_Timer.hpp"
61 template<
typename IntType >
68 return k + N * ( j + N * i );
73 std::vector< std::vector<size_t> > & graph )
75 graph.resize( N * N * N , std::vector<size_t>() );
79 for (
int i = 0 ; i < (int) N ; ++i ) {
80 for (
int j = 0 ;
j < (int) N ; ++
j ) {
81 for (
int k = 0 ; k < (int) N ; ++k ) {
85 graph[row].reserve(27);
87 for (
int ii = -1 ; ii < 2 ; ++ii ) {
88 for (
int jj = -1 ; jj < 2 ; ++jj ) {
89 for (
int kk = -1 ; kk < 2 ; ++kk ) {
90 if ( 0 <= i + ii && i + ii < (
int) N &&
91 0 <=
j + jj &&
j + jj < (
int) N &&
92 0 <= k + kk && k + kk < (
int) N ) {
95 graph[row].push_back(col);
98 total += graph[row].size();
104 template <
typename ScalarType,
typename OrdinalType,
typename Device>
107 const OrdinalType dim,
108 const OrdinalType nGrid,
109 const OrdinalType iterCount,
110 std::vector<double>& scalar_perf,
111 std::vector<double>& block_left_perf,
112 std::vector<double>& block_right_perf,
113 std::vector<double>& pce_perf,
114 std::vector<double>& block_pce_perf)
123 typedef Kokkos::View< value_type*, Kokkos::LayoutLeft, execution_space > scalar_vector_type;
124 typedef Kokkos::View< value_type**, Kokkos::LayoutLeft, execution_space > scalar_left_multi_vector_type;
125 typedef Kokkos::View< value_type**, Kokkos::LayoutRight, execution_space > scalar_right_multi_vector_type;
126 typedef Kokkos::View< pce_type*, Kokkos::LayoutLeft, execution_space > pce_vector_type;
127 typedef Kokkos::View< pce_type**, Kokkos::LayoutLeft, execution_space > pce_multi_vector_type;
129 typedef KokkosSparse::CrsMatrix< value_type, ordinal_type, execution_space > scalar_matrix_type;
130 typedef KokkosSparse::CrsMatrix< pce_type, ordinal_type, execution_space > pce_matrix_type;
131 typedef typename scalar_matrix_type::StaticCrsGraphType matrix_graph_type;
132 typedef typename scalar_matrix_type::values_type scalar_matrix_values_type;
133 typedef typename pce_matrix_type::values_type pce_matrix_values_type;
140 typedef typename pce_type::cijk_type kokkos_cijk_type;
147 const ordinal_type num_pce_col = 5;
150 Array< RCP<const abstract_basis_type> > bases(dim);
151 for (ordinal_type i=0; i<dim; ++i) {
154 RCP<const product_basis_type> basis =
rcp(
new product_basis_type(bases));
155 RCP<cijk_type>
cijk = basis->computeTripleProductTensor();
156 kokkos_cijk_type kokkos_cijk =
157 Stokhos::create_product_tensor<execution_space>(*basis, *
cijk);
163 std::vector< std::vector<size_t> > fem_graph;
164 const size_t fem_length = nGrid * nGrid * nGrid;
170 ordinal_type pce_size = basis->size();
171 scalar_left_multi_vector_type xl(Kokkos::ViewAllocateWithoutInitializing(
"scalar left x"), fem_length, pce_size);
172 scalar_left_multi_vector_type yl(Kokkos::ViewAllocateWithoutInitializing(
"scalar right y"), fem_length, pce_size);
173 scalar_right_multi_vector_type xr(Kokkos::ViewAllocateWithoutInitializing(
"scalar right x"), fem_length, pce_size);
174 scalar_right_multi_vector_type yr(Kokkos::ViewAllocateWithoutInitializing(
"scalar right y"), fem_length, pce_size);
175 std::vector<scalar_vector_type> x_col(pce_size), y_col(pce_size);
176 for (ordinal_type i=0; i<pce_size; ++i) {
177 x_col[i] = scalar_vector_type (Kokkos::ViewAllocateWithoutInitializing(
"scalar x col"), fem_length);
178 y_col[i] = scalar_vector_type(Kokkos::ViewAllocateWithoutInitializing(
"scalar y col"), fem_length);
182 pce_vector_type x_pce =
183 Kokkos::make_view<pce_vector_type>(Kokkos::ViewAllocateWithoutInitializing(
"pce x"),
184 kokkos_cijk, fem_length, pce_size);
185 pce_vector_type y_pce =
186 Kokkos::make_view<pce_vector_type>(Kokkos::ViewAllocateWithoutInitializing(
"pce y"),
187 kokkos_cijk, fem_length, pce_size);
188 pce_multi_vector_type x_multi_pce =
189 Kokkos::make_view<pce_multi_vector_type>(Kokkos::ViewAllocateWithoutInitializing(
"pce multi x"),
190 kokkos_cijk, fem_length,
191 num_pce_col, pce_size);
192 pce_multi_vector_type y_multi_pce =
193 Kokkos::make_view<pce_multi_vector_type>(Kokkos::ViewAllocateWithoutInitializing(
"pce multi y"),
194 kokkos_cijk, fem_length,
195 num_pce_col, pce_size);
209 matrix_graph_type matrix_graph =
210 Kokkos::create_staticcrsgraph<matrix_graph_type>(
211 std::string(
"test crs graph"), fem_graph);
212 scalar_matrix_values_type scalar_matrix_values =
213 scalar_matrix_values_type(Kokkos::ViewAllocateWithoutInitializing(
"scalar matrix"), graph_length);
214 pce_matrix_values_type pce_matrix_values =
215 Kokkos::make_view<pce_matrix_values_type>(Kokkos::ViewAllocateWithoutInitializing(
"pce matrix"), kokkos_cijk, graph_length, 1);
216 scalar_matrix_type scalar_matrix(
"scalar matrix", fem_length,
217 scalar_matrix_values, matrix_graph);
218 pce_matrix_type pce_matrix(
"pce matrix", fem_length,
219 pce_matrix_values, matrix_graph);
229 for (ordinal_type iter = 0; iter < iterCount; ++iter) {
230 for (ordinal_type col=0; col<pce_size; ++col) {
241 Kokkos::Impl::Timer clock ;
242 for (ordinal_type iter = 0; iter < iterCount; ++iter) {
243 for (ordinal_type col=0; col<pce_size; ++col) {
254 const double seconds_per_iter = clock.seconds() / ((
double) iterCount );
255 const double flops = 1.0e-9 * 2.0 * graph_length * pce_size;
257 scalar_perf.resize(5);
258 scalar_perf[0] = fem_length;
259 scalar_perf[1] = pce_size;
260 scalar_perf[2] = graph_length;
261 scalar_perf[3] = seconds_per_iter;
262 scalar_perf[4] = flops / seconds_per_iter;
270 for (ordinal_type iter = 0; iter < iterCount; ++iter) {
275 Kokkos::Impl::Timer clock ;
276 for (ordinal_type iter = 0; iter < iterCount; ++iter) {
281 const double seconds_per_iter = clock.seconds() / ((
double) iterCount );
282 const double flops = 1.0e-9 * 2.0 * graph_length * pce_size;
284 block_left_perf.resize(5);
285 block_left_perf[0] = fem_length;
286 block_left_perf[1] = pce_size;
287 block_left_perf[2] = graph_length;
288 block_left_perf[3] = seconds_per_iter;
289 block_left_perf[4] = flops / seconds_per_iter;
297 for (ordinal_type iter = 0; iter < iterCount; ++iter) {
302 Kokkos::Impl::Timer clock ;
303 for (ordinal_type iter = 0; iter < iterCount; ++iter) {
308 const double seconds_per_iter = clock.seconds() / ((
double) iterCount );
309 const double flops = 1.0e-9 * 2.0 * graph_length * pce_size;
311 block_right_perf.resize(5);
312 block_right_perf[0] = fem_length;
313 block_right_perf[1] = pce_size;
314 block_right_perf[2] = graph_length;
315 block_right_perf[3] = seconds_per_iter;
316 block_right_perf[4] = flops / seconds_per_iter;
324 for (ordinal_type iter = 0; iter < iterCount; ++iter) {
329 Kokkos::Impl::Timer clock ;
330 for (ordinal_type iter = 0; iter < iterCount; ++iter) {
335 const double seconds_per_iter = clock.seconds() / ((
double) iterCount );
336 const double flops = 1.0e-9 * 2.0 * graph_length * pce_size;
339 pce_perf[0] = fem_length;
340 pce_perf[1] = pce_size;
341 pce_perf[2] = graph_length;
342 pce_perf[3] = seconds_per_iter;
343 pce_perf[4] = flops / seconds_per_iter;
351 for (ordinal_type iter = 0; iter < iterCount; ++iter) {
356 Kokkos::Impl::Timer clock ;
357 for (ordinal_type iter = 0; iter < iterCount; ++iter) {
362 const double seconds_per_iter = clock.seconds() / ((
double) iterCount );
363 const double flops = 1.0e-9 * 2.0 * graph_length * pce_size * num_pce_col;
365 block_pce_perf.resize(5);
366 block_pce_perf[0] = fem_length;
367 block_pce_perf[1] = pce_size;
368 block_pce_perf[2] = graph_length;
369 block_pce_perf[3] = seconds_per_iter;
370 block_pce_perf[4] = flops / seconds_per_iter;
375 template <
typename Scalar,
typename Ordinal,
typename Device>
382 std::cout.precision(8);
383 std::cout << std::endl
384 <<
"\"Grid Size\" , "
386 <<
"\"FEM Graph Size\" , "
387 <<
"\"Dimension\" , "
390 <<
"\"Scalar SpMM Time\" , "
391 <<
"\"Scalar SpMM Speedup\" , "
392 <<
"\"Scalar SpMM GFLOPS\" , "
393 <<
"\"Block-Left SpMM Speedup\" , "
394 <<
"\"Block-Left SpMM GFLOPS\" , "
395 <<
"\"Block-Right SpMM Speedup\" , "
396 <<
"\"Block-Right SpMM GFLOPS\" , "
397 <<
"\"PCE SpMM Speedup\" , "
398 <<
"\"PCE SpMM GFLOPS\" , "
399 <<
"\"Block PCE SpMM Speedup\" , "
400 <<
"\"Block PCE SpMM GFLOPS\" , "
403 std::vector<double> perf_scalar, perf_block_left, perf_block_right,
404 perf_pce, perf_block_pce;
405 for (
Ordinal dim=min_var; dim<=max_var; ++dim) {
407 test_mean_multiply<Scalar,Ordinal,Device>(
408 order, dim, nGrid, nIter, perf_scalar, perf_block_left, perf_block_right,
409 perf_pce, perf_block_pce );
411 std::cout << nGrid <<
" , "
412 << perf_scalar[0] <<
" , "
413 << perf_scalar[2] <<
" , "
416 << perf_scalar[1] <<
" , "
417 << perf_scalar[3] <<
" , "
418 << perf_scalar[4] / perf_scalar[4] <<
" , "
419 << perf_scalar[4] <<
" , "
420 << perf_block_left[4]/ perf_scalar[4] <<
" , "
421 << perf_block_left[4] <<
" , "
422 << perf_block_right[4]/ perf_scalar[4] <<
" , "
423 << perf_block_right[4] <<
" , "
424 << perf_pce[4]/ perf_scalar[4] <<
" , "
425 << perf_pce[4] <<
" , "
426 << perf_block_pce[4]/ perf_scalar[4] <<
" , "
427 << perf_block_pce[4] <<
" , "
433 #define INST_PERF_DRIVER(SCALAR, ORDINAL, DEVICE) \
434 template void performance_test_driver< SCALAR, ORDINAL, DEVICE >( \
435 const ORDINAL nGrid, const ORDINAL nIter, const ORDINAL order, \
436 const ORDINAL min_var, const ORDINAL max_var);
Stokhos::StandardStorage< int, double > storage_type
Sacado::ETPCE::OrthogPoly< double, Stokhos::StandardStorage< int, double > > pce_type
Multivariate orthogonal polynomial basis generated from a total order tensor product of univariate po...
Data structure storing a sparse 3-tensor C(i,j,k) in a a compressed format.
ordinal generate_fem_graph(ordinal N, std::vector< std::vector< ordinal > > &graph)
Kokkos::DefaultExecutionSpace execution_space
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)
IntType map_fem_graph_coord(const IntType &N, const IntType &i, const IntType &j, const IntType &k)
Stokhos::LegendreBasis< int, double > basis_type
TEUCHOS_DEPRECATED RCP< T > rcp(T *p, Dealloc_T dealloc, bool owns_mem)
void deep_copy(const Stokhos::CrsMatrix< ValueType, DstDevice, Layout > &dst, const Stokhos::CrsMatrix< ValueType, SrcDevice, Layout > &src)
void setGlobalCijkTensor(const cijk_type &cijk)
KOKKOS_INLINE_FUNCTION constexpr std::enable_if< is_view_uq_pce< view_type >::value, typename CijkType< view_type >::type >::type cijk(const view_type &view)
Legendre polynomial basis.
void performance_test_driver(const Teuchos::RCP< const Teuchos::Comm< int > > &comm, const int use_print, const int use_trials, const int use_nodes[], const bool check, Kokkos::Example::FENL::DeviceConfig dev_config)
Abstract base class for 1-D orthogonal polynomials.
A comparison functor implementing a strict weak ordering based lexographic ordering.
std::enable_if< Kokkos::is_view_uq_pce< Kokkos::View< InputType, InputP... > >::value &&Kokkos::is_view_uq_pce< Kokkos::View< OutputType, OutputP... > >::value >::type spmv(const char mode[], const AlphaType &a, const MatrixType &A, const Kokkos::View< InputType, InputP... > &x, const BetaType &b, const Kokkos::View< OutputType, OutputP... > &y, const RANK_ONE)