Sacado Package Browser (Single Doxygen Collection) Version of the Day
Loading...
Searching...
No Matches
mat_vec_hierarchical.cpp
Go to the documentation of this file.
1// @HEADER
2// ***********************************************************************
3//
4// Sacado Package
5// Copyright (2006) Sandia Corporation
6//
7// Under the terms of Contract DE-AC04-94AL85000 with Sandia Corporation,
8// the U.S. Government retains certain rights in this software.
9//
10// This library is free software; you can redistribute it and/or modify
11// it under the terms of the GNU Lesser General Public License as
12// published by the Free Software Foundation; either version 2.1 of the
13// License, or (at your option) any later version.
14//
15// This library is distributed in the hope that it will be useful, but
16// WITHOUT ANY WARRANTY; without even the implied warranty of
17// MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
18// Lesser General Public License for more details.
19//
20// You should have received a copy of the GNU Lesser General Public
21// License along with this library; if not, write to the Free Software
22// Foundation, Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301
23// USA
24// Questions? Contact David M. Gay (dmgay@sandia.gov) or Eric T. Phipps
25// (etphipp@sandia.gov).
26//
27// ***********************************************************************
28// @HEADER
29
30#define SACADO_VIEW_CUDA_HIERARCHICAL 1
31#define SACADO_ALIGN_SFAD 1
32
33#include "Sacado.hpp"
34
36
37#include "Kokkos_Timer.hpp"
38
39template <typename ViewTypeA, typename ViewTypeB, typename ViewTypeC>
40void run_mat_vec_hierarchical(const ViewTypeA& A, const ViewTypeB& b,
41 const ViewTypeC& c) {
42 typedef typename Kokkos::ThreadLocalScalarType<ViewTypeC>::type scalar_type;
43 typedef typename ViewTypeC::execution_space execution_space;
44
45#if defined (KOKKOS_ENABLE_CUDA)
46 const bool is_cuda = std::is_same<execution_space, Kokkos::Cuda>::value;
47#else
48 const bool is_cuda = false;
49#endif
50 const unsigned vector_size = is_cuda ? 32 : 1;
51 const unsigned team_size = is_cuda ? 128 / vector_size : 1;
52
53 const int m = A.extent(0);
54 const int n = A.extent(1);
55 const int range = (m+team_size-1)/team_size;
56
57 typedef Kokkos::TeamPolicy<execution_space> Policy;
58 Kokkos::parallel_for(
59 Policy( range,team_size,vector_size ),
60 KOKKOS_LAMBDA (const typename Policy::member_type& team) {
61 const int i = team.league_rank()*team.team_size() + team.team_rank();
62 if (i >= m)
63 return;
64
65 scalar_type t = 0.0;
66 for (int j=0; j<n; ++j)
67 t += A(i,j)*b(j);
68 c(i) = t;
69 }
70 );
71}
72
73template <typename ViewTypeA, typename ViewTypeB, typename ViewTypeC>
74void
75check_deriv_hierarchical(const ViewTypeA& A, const ViewTypeB& b, const ViewTypeC& c)
76{
77 const double tol = 1.0e-14;
78 typedef typename ViewTypeC::value_type value_type;
79 typename ViewTypeC::HostMirror h_c = Kokkos::create_mirror_view(c);
80 Kokkos::deep_copy(h_c, c);
81 const size_t m = A.extent(0);
82 const size_t n = A.extent(1);
83 const size_t p = Kokkos::dimension_scalar(A);
84 for (size_t i=0; i<m; ++i) {
85 for (size_t j=0; j<p; ++j) {
86 value_type t = (j == p-1 ? n : 2*n);
87 if (std::abs(h_c(i).fastAccessDx(j)- t) > tol) {
88 std::cout << "Comparison failed! " << i << "," << j << " : "
89 << h_c(i).fastAccessDx(j) << " , " << t << std::endl;
90 }
91 }
92 }
93}
94
95template <typename FadType, typename ... ViewArgs>
96Perf
97do_time_fad_hierarchical(const size_t m, const size_t n, const size_t p,
98 const size_t nloop, const bool check)
99{
100 typedef Kokkos::View<FadType**, ViewArgs...> ViewTypeA;
101 typedef Kokkos::View<FadType*, ViewArgs...> ViewTypeB;
102 typedef Kokkos::View<FadType*, ViewArgs...> ViewTypeC;
103 typedef typename ViewTypeA::execution_space execution_space;
104
105#if defined (KOKKOS_ENABLE_CUDA)
106 const bool is_cuda = std::is_same<execution_space, Kokkos::Cuda>::value;
107#else
108 const bool is_cuda = false;
109#endif
110
111 const int FadStride = is_cuda ? 32 : 1;
112#if defined(SACADO_ALIGN_SFAD)
114 const int Nalign = ((N+FadStride-1)/FadStride)*FadStride;
115 const size_t pa = N > 0 ? ((p+FadStride-1)/FadStride)*FadStride : p;
116 typedef typename FadType::template apply_N<Nalign>::type AlignedFadType;
117#else
118 typedef FadType AlignedFadType;
119 const size_t pa = p;
120#endif
121
125
126 typedef Kokkos::View<AlignedFadType**, ConLayoutA, execution_space> ConViewTypeA;
127 typedef Kokkos::View<AlignedFadType*, ConLayoutB, execution_space> ConViewTypeB;
128 typedef Kokkos::View<AlignedFadType*, ConLayoutC, execution_space> ConViewTypeC;
129
130 ConViewTypeA A("A",m,n,pa+1);
131 ConViewTypeB b("B",n,pa+1);
132 ConViewTypeC c("c",m,pa+1);
133
134 // AlignedFadType a(pa, 1.0);
135 // for (size_t k=0; k<pa; ++k)
136 // a.fastAccessDx(k) = 1.0;
137 Kokkos::deep_copy(typename ConViewTypeA::array_type(A), 1.0);
138 Kokkos::deep_copy(typename ConViewTypeB::array_type(b), 1.0);
139
140 Kokkos::Timer wall_clock;
141 Perf perf;
142
143 // Execute the kernel once to warm up
145 execution_space().fence();
146
147 wall_clock.reset();
148 for (size_t l=0; l<nloop; l++) {
150 }
151 execution_space().fence();
152
153 perf.time = wall_clock.seconds() / nloop;
154 perf.flops = m*n*(2+4*p);
155 perf.throughput = perf.flops / perf.time / 1.0e9;
156
157 if (check) {
159 }
160
161 return perf;
162}
163
166
167#define INST_FUNC_FAD_DEV(FAD,DEV) \
168 template Perf do_time_fad_hierarchical< FAD, Kokkos::LayoutLeft, DEV > ( const size_t m, const size_t n, const size_t p, const size_t nloop, const bool check ); \
169 template Perf do_time_fad_hierarchical< FAD, Kokkos::LayoutRight, DEV > ( const size_t m, const size_t n, const size_t p, const size_t nloop, const bool check ); \
170 template Perf do_time_fad_hierarchical< FAD, DEV > ( const size_t m, const size_t n, const size_t p, const size_t nloop, const bool check );
171
172#define INST_FUNC_DEV(DEV) \
173 INST_FUNC_FAD_DEV( SFad_type, DEV ) \
174 INST_FUNC_FAD_DEV( SLFad_type, DEV )
175
176#ifdef KOKKOS_ENABLE_SERIAL
177INST_FUNC_DEV(Kokkos::Serial)
178#endif
179
180#ifdef KOKKOS_ENABLE_OPENMP
181INST_FUNC_DEV(Kokkos::OpenMP)
182#endif
183
184#ifdef KOKKOS_ENABLE_THREADS
185INST_FUNC_DEV(Kokkos::Threads)
186#endif
187
188#ifdef KOKKOS_ENABLE_CUDA
189INST_FUNC_DEV(Kokkos::Cuda)
190#endif
expr expr expr fastAccessDx(i)) FAD_UNARYOP_MACRO(exp
expr expr1 expr1 expr1 c expr2 expr1 expr2 expr1 expr2 expr1 expr1 expr1 expr1 c expr2 expr1 expr2 expr1 expr2 expr1 expr1 expr1 expr1 c *expr2 expr1 expr2 expr1 expr2 expr1 expr1 expr1 expr1 c expr2 expr1 expr2 expr1 expr2 expr1 expr1 expr1 expr2 expr1 expr2 expr1 expr1 expr1 expr2 expr1 expr2 expr1 expr1 expr1 c
#define A
const int N
Sacado::Fad::DFad< double > FadType
Fad specializations for Teuchos::BLAS wrappers.
int check(Epetra_CrsGraph &A, int NumMyRows1, int NumGlobalRows1, int NumMyNonzeros1, int NumGlobalNonzeros1, int *MyGlobalElements, bool verbose)
const char * p
#define INST_FUNC_DEV(DEV)
void run_mat_vec_hierarchical(const ViewTypeA &A, const ViewTypeB &b, const ViewTypeC &c)
Perf do_time_fad_hierarchical(const size_t m, const size_t n, const size_t p, const size_t nloop, const bool check)
Sacado::Fad::SFad< double, HierSFadSize > SFad_type
void check_deriv_hierarchical(const ViewTypeA &A, const ViewTypeB &b, const ViewTypeC &c)
Sacado::Fad::SLFad< double, HierSLFadSize > SLFad_type
double time
double flops
double throughput
Base template specification for static size.
const double tol