21 template<
class Device, VarType VT, PhiInterpType PIT, TorType TT, KinType KT, ScatterType ST = ScatterType::Atomic>
25 template<
class Device, VarType VT, PhiInterpType PIT>
31 Kokkos::View<field_type*,Kokkos::LayoutRight,Device>
f;
34 GridField(std::string name,
int nphi,
int nrho,
int nnode) : f(name,nnode) {}
35 GridField(std::string name,
int nnode) : f(name,nnode) {}
37 int size()
const {
return f.size();}
38 int nnode()
const {
return f.extent(0);}
40 int nphi()
const {
return 1;}
42 KOKKOS_INLINE_FUNCTION
bool is_allocated()
const {
return f.is_allocated();}
43 KOKKOS_INLINE_FUNCTION
field_type& operator ()(
int inode)
const {
return f(inode);}
47 f(node).scatter(phi_wts, i_simd, particle_weight);
52 for (
int j = 0; j<3; j++){
55 double wp=grid_wts.p[j][i_simd];
58 scatter(node, grid_wts.phi_wts, i_simd, wp*particle_weight);
67 for (
int i_simd = 0; i_simd<SIMD_SIZE; i_simd++){
68 if(grid_wts.is_invalid(i_simd))
continue;
71 for (
int ip = 0; ip<3; ip++){
73 double wp = grid_wts.p[ip][i_simd];
74 f(node).gather(fld,i_simd,wp);
84 for (
int i_simd = 0; i_simd<SIMD_SIZE; i_simd++){
85 if(grid_wts.is_invalid(i_simd))
continue;
88 for (
int ip = 0; ip<3; ip++){
90 double wp = grid_wts.p[ip][i_simd];
91 f(node).gather(fld,i_simd,wp,grid_wts.phi_wts);
97 int ndoubles_in_grid_field = f.size()*field_type::SIZE();
98 Kokkos::View<double*,Kokkos::LayoutRight,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>> view_1d_double((
double*)(data()), ndoubles_in_grid_field);
99 Kokkos::deep_copy(view_1d_double, 0.0);
107 View<double*,CLayout,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>> f_unmanaged((
double*)data(),nnode());
109 Kokkos::deep_copy(dest_view, f_unmanaged);
112 View<double*,CLayout,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>>
unmanaged()
const{
113 return View<double*,CLayout,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>>((
double*)(f.data()), f.layout());
120 constexpr
int n_phi = field_type::NPHI();
123 View<double**,CLayout,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>> f_unmanaged((
double*)data(),nnode(), n_phi);
126 Kokkos::parallel_for(
"var_transpose_copy", Kokkos::RangePolicy<typename Device::execution_space>( 0, nnode()), KOKKOS_LAMBDA(
const int inode){
127 for(
int iphi=0; iphi<n_phi; iphi++){
128 dest_view(iphi, inode) = f_unmanaged(inode, iphi);
137 constexpr
int n_phi = field_type::NPHI();
140 View<double**,CLayout,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>> f_unmanaged((
double*)data(),nnode(), n_phi);
143 Kokkos::parallel_for(
"var_transpose_copy", Kokkos::RangePolicy<ExSpace>( 0, nnode()), KOKKOS_LAMBDA(
const int inode){
144 for(
int iphi=0; iphi<n_phi; iphi++){
145 f_unmanaged(inode, iphi) = src_view(iphi, inode);
153 static KOKKOS_INLINE_FUNCTION
void view_gather3(
const Grid<DeviceType>& grid,
const View<double*,CLayout,Device>& view1,
const View<double*,CLayout,Device>& view2,
const View<double*,CLayout,Device>& view3,
const SimdGridWeights<Order::One, PIT_GLOBAL>& grid_wts,
double& val1,
double& val2,
double& val3,
int i_simd){
157 for (
int ip=0; ip<3; ip++){
159 val1 += view1(nd)*grid_wts.p[ip][i_simd];
160 val2 += view2(nd)*grid_wts.p[ip][i_simd];
161 val3 += view3(nd)*grid_wts.p[ip][i_simd];
167 for (
int i_simd = 0; i_simd<SIMD_SIZE; i_simd++){
168 if(grid_wts.itr[i_simd]<=0)
continue;
169 for (
int ip = 0; ip < 3; ip++){
171 val[i_simd] += grid_wts.p[ip][i_simd]*view(node);
179 val.
phi[i_simd] = 0.0;
180 for (
int ip = 0; ip<3; ip++){
182 double wp = grid_wts.p[ip][i_simd];
183 view(ind,node).gather(val, i_simd, wp);
187 static KOKKOS_INLINE_FUNCTION
void view_gyro_scatter3(
const Grid<DeviceType>& grid,
const View<double**,CLayout,Device>& view1,
const View<double**,CLayout,Device>& view2,
const View<double**,CLayout,Device>& view3,
const SimdGridWeights<Order::One, PIT_GLOBAL>& grid_wts,
double val1,
double val2,
double val3,
int i_simd,
const LinearWeights& rho_wts,
bool is_gyro){
189 for (
int ip = 0; ip < 3; ip++){
191 Kokkos::atomic_add(&(view1(rho_wts.
i, node)), grid_wts.p[ip][i_simd]*rho_wts.
w[0]*val1);
192 Kokkos::atomic_add(&(view2(rho_wts.
i, node)), grid_wts.p[ip][i_simd]*rho_wts.
w[0]*val2);
193 Kokkos::atomic_add(&(view3(rho_wts.
i, node)), grid_wts.p[ip][i_simd]*rho_wts.
w[0]*val3);
195 Kokkos::atomic_add(&(view1(rho_wts.
i+1, node)), grid_wts.p[ip][i_simd]*rho_wts.
w[1]*val1);
196 Kokkos::atomic_add(&(view2(rho_wts.
i+1, node)), grid_wts.p[ip][i_simd]*rho_wts.
w[1]*val2);
197 Kokkos::atomic_add(&(view3(rho_wts.
i+1, node)), grid_wts.p[ip][i_simd]*rho_wts.
w[1]*val3);
204 for (
int j = 0; j<3; j++){
206 double wp=grid_wts.p[j][i_simd];
208 Kokkos::atomic_add(&(view(ind,node)), wp*val);
213 for (
int j = 0; j<3; j++){
215 double wp=grid_wts.p[j][i_simd];
217 Kokkos::atomic_add(&(view(node)), wp*val);
222 for (
int j = 0; j<3; j++){
224 double wp=grid_wts.p[j][i_simd];
226 Kokkos::atomic_add(&(view(0,node)), wp*wphi*val);
227 Kokkos::atomic_add(&(view(1,node)), wp*(1.0-wphi)*val);
231 static KOKKOS_INLINE_FUNCTION
void view_odim_variance(
const Grid<DeviceType>& grid,
const View<double**,CLayout,Device>& view,
const View<double**,CLayout,Device>& variance,
int ind,
const SimdGridWeights<Order::One, PIT_GLOBAL>& grid_wts,
double val,
int i_simd){
232 for (
int j = 0; j<3; j++){
234 double wp=grid_wts.p[j][i_simd];
236 double tmp = view(ind,node) - wp*val;
237 Kokkos::atomic_add(&(variance(ind,node)), tmp*tmp);
241 static KOKKOS_INLINE_FUNCTION
void view_rep_scatter3(
const Grid<DeviceType>& grid,
const View<double***,CLayout,Device>& view,
int ind1,
int ind2,
int ind3,
const SimdGridWeights<Order::One, PIT_GLOBAL>& grid_wts,
double val1,
double val2,
double val3,
int ithread,
int i_simd){
243 for (
int ip = 0; ip < 3; ip++){
245 double wp = grid_wts.p[ip][i_simd];
247 access_add(&(view(ithread,node,ind1)),wp*val1);
248 access_add(&(view(ithread,node,ind2)),wp*val2);
249 access_add(&(view(ithread,node,ind3)),wp*val3);
254 template<
class Device, VarType VT, PhiInterpType PIT>
260 Kokkos::View<field_type**,Kokkos::LayoutRight,Device>
f;
263 GridField(std::string name,
int nphi,
int nrho,
int nnode) : f(name,nnode, nrho+1) {}
264 GridField(std::string name,
int nrho,
int nnode) : f(name,nnode, nrho+1) {}
266 int size()
const {
return f.size();}
267 int nnode()
const {
return f.extent(0);}
270 KOKKOS_INLINE_FUNCTION
bool is_allocated()
const {
return f.is_allocated();}
271 KOKKOS_INLINE_FUNCTION
field_type& operator ()(
int inode,
int irho)
const {
return f(inode, irho);}
275 int irho = rho_wts.
irho(i_simd);
276 f(node,irho).scatter(rho_wts, phi_wts, i_simd, particle_weight, f(node,irho+1));
281 for (
int j = 0; j<3; j++){
284 double wp=grid_wts.p[j][i_simd];
287 scatter(node, grid_wts.phi_wts, rho_wts, i_simd, wp*particle_weight);
292 int ndoubles_in_grid_field = f.size()*field_type::SIZE();
293 Kokkos::View<double*,Kokkos::LayoutRight,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>> view_1d_double((
double*)(f.data()), ndoubles_in_grid_field);
294 Kokkos::deep_copy(view_1d_double, 0.0);
299 template<
class Device, VarType VT, PhiInterpType PIT>
305 Kokkos::View<field_type**,Kokkos::LayoutRight,Device>
f;
311 int size()
const {
return f.size();}
312 int nnode()
const {
return f.extent(1);}
315 KOKKOS_INLINE_FUNCTION
bool is_allocated()
const {
return f.is_allocated();}
316 KOKKOS_INLINE_FUNCTION
field_type& operator ()(
int ithread,
int inode)
const {
return f(ithread, inode);}
320 f(ithread,node).scatter(phi_wts, i_simd, particle_weight);
325 for (
int j = 0; j<3; j++){
328 double wp=grid_wts.p[j][i_simd];
331 scatter(ithread, node, grid_wts.phi_wts, i_simd, wp*particle_weight);
336 int ndoubles_in_grid_field = f.size()*field_type::SIZE();
337 Kokkos::View<double*,Kokkos::LayoutRight,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>> view_1d_double((
double*)(f.data()), ndoubles_in_grid_field);
338 Kokkos::deep_copy(view_1d_double, 0.0);
342 template<
class Device, VarType VT, PhiInterpType PIT>
348 Kokkos::View<field_type***,Kokkos::LayoutRight,Device>
f;
354 int size()
const {
return f.size();}
355 int nnode()
const {
return f.extent(1);}
358 KOKKOS_INLINE_FUNCTION
bool is_allocated()
const {
return f.is_allocated();}
359 KOKKOS_INLINE_FUNCTION
field_type& operator ()(
int ithread,
int inode,
int irho)
const {
return f(ithread,inode, irho);}
363 int irho = rho_wts.
irho(i_simd);
364 f(ithread,node,irho).scatter(rho_wts, phi_wts, i_simd, particle_weight, f(ithread,node,irho+1));
369 for (
int j = 0; j<3; j++){
372 double wp=grid_wts.p[j][i_simd];
375 scatter(ithread, node, grid_wts.phi_wts, rho_wts, i_simd, wp*particle_weight);
380 int ndoubles_in_grid_field = f.size()*field_type::SIZE();
381 Kokkos::View<double*,Kokkos::LayoutRight,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>> view_1d_double((
double*)(f.data()), ndoubles_in_grid_field);
382 Kokkos::deep_copy(view_1d_double, 0.0);
387 template<
class Device, VarType VT, PhiInterpType PIT>
393 Kokkos::View<field_type**,Kokkos::LayoutRight,Device>
f;
396 GridField(std::string name,
int nphi,
int nrho,
int nnode) : f(name,nphi, nnode) {}
397 GridField(std::string name,
int nphi,
int nnode) : f(name,nphi, nnode) {}
399 int size()
const {
return f.size();}
400 int nnode()
const {
return f.extent(1);}
402 int nphi()
const {
return f.extent(0);}
403 KOKKOS_INLINE_FUNCTION
bool is_allocated()
const {
return f.is_allocated();}
404 KOKKOS_INLINE_FUNCTION
field_type& operator ()(
int iphi,
int inode)
const {
return f(iphi, inode);}
412 Kokkos::View<double**,Kokkos::LayoutRight,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>>
unmanaged()
const{
413 return Kokkos::View<double**,Kokkos::LayoutRight,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>>((
double*)(f.data()), f.layout());
417 template<
class Device, VarType VT, PhiInterpType PIT>
423 Kokkos::View<field_type***,Kokkos::LayoutRight,Device>
f;
426 GridField(std::string name,
int nphi,
int nrho,
int nnode) : f(name,nphi, nnode, nrho+1) {}
428 int size()
const {
return f.size();}
429 int nnode()
const {
return f.extent(1);}
431 int nphi()
const {
return f.extent(0);}
432 KOKKOS_INLINE_FUNCTION
bool is_allocated()
const {
return f.is_allocated();}
433 KOKKOS_INLINE_FUNCTION
field_type& operator ()(
int iphi,
int inode,
int irho)
const {
return f(iphi, inode, irho);}
457 template<
typename T1,
typename T2>
460 dest = T1(
"grid_field",src.nphi(), src.nrhop1()-1, src.nnode());
462 Kokkos::deep_copy(dest.f, src.f);
Definition: field.hpp:276
static KOKKOS_INLINE_FUNCTION void view_odim_scatter(const Grid< DeviceType > &grid, const View< double **, CLayout, Device > &view, int ind, const SimdGridWeights< Order::One, PIT_GLOBAL > &grid_wts, double val, int i_simd)
Definition: grid_field.hpp:203
GridField< DeviceType, VarType::Vector2D, PhiInterpType::None, TorType::OnePlane, KinType::GyroKin > Efield2DGyroType
Definition: grid_field.hpp:445
Simd< double > r
Definition: simd.hpp:150
int size() const
Definition: grid_field.hpp:399
GridField(std::string name, int nphi, int nrho, int nnode)
Definition: grid_field.hpp:34
Device device_type
Definition: grid_field.hpp:345
static KOKKOS_INLINE_FUNCTION void view_gather3(const Grid< DeviceType > &grid, const View< double *, CLayout, Device > &view1, const View< double *, CLayout, Device > &view2, const View< double *, CLayout, Device > &view3, const SimdGridWeights< Order::One, PIT_GLOBAL > &grid_wts, double &val1, double &val2, double &val3, int i_simd)
Definition: grid_field.hpp:153
Device device_type
Definition: grid_field.hpp:390
int nnode() const
Definition: grid_field.hpp:355
KOKKOS_INLINE_FUNCTION void scatter(const Grid< DeviceType > &grid, int ithread, const SimdGridWeights< Order::One, PIT_GLOBAL > &grid_wts, int i_simd, const SimdGyroWeights< DriftKin > &rho_wts, double particle_weight) const
Definition: grid_field.hpp:324
GridField(std::string name, int nphi, int nrho, int nnode)
Definition: grid_field.hpp:396
int nphi() const
Definition: grid_field.hpp:357
GridField< DeviceType, VarType::Scalar, PIT_GLOBAL, TorType::MultiplePlanes, KinType::DriftKin > PotType
Definition: grid_field.hpp:442
KOKKOS_INLINE_FUNCTION bool is_allocated() const
Definition: grid_field.hpp:42
int size() const
Definition: grid_field.hpp:37
GridField(std::string name, int nrho, int nnode)
Definition: grid_field.hpp:264
void transpose_copy_to_double_view(const View< double **, CLayout, Device > &dest_view) const
Definition: grid_field.hpp:118
KOKKOS_INLINE_FUNCTION int irho(int i_simd) const
Definition: gyro_radius.hpp:107
KOKKOS_INLINE_FUNCTION bool is_allocated() const
Definition: grid_field.hpp:270
static KOKKOS_INLINE_FUNCTION void view_gyro_scatter3(const Grid< DeviceType > &grid, const View< double **, CLayout, Device > &view1, const View< double **, CLayout, Device > &view2, const View< double **, CLayout, Device > &view3, const SimdGridWeights< Order::One, PIT_GLOBAL > &grid_wts, double val1, double val2, double val3, int i_simd, const LinearWeights &rho_wts, bool is_gyro)
Definition: grid_field.hpp:187
void scatter(const Grid< DeviceType > &grid, const MagneticField< DeviceType > &magnetic_field, const GridFieldPack< DeviceType, PIT > &gfpack, const Species< DeviceType > &species, bool exclude_private, bool do_cv_adjustment, bool cv_full_weight, const Charge< DeviceType, KT > &charge)
Definition: scatter.cpp:239
GridField(std::string name, int nrho, int nnode)
Definition: grid_field.hpp:352
void copy_to_double_view(const View< double *, CLayout, Device > &dest_view) const
Definition: grid_field.hpp:105
static KOKKOS_INLINE_FUNCTION void view_ff_scatter(const Grid< DeviceType > &grid, const View< double **, CLayout, Device > &view, const SimdGridWeights< Order::One, PhiInterpType::Planes > &grid_wts, double wphi, double val, int i_simd)
Definition: grid_field.hpp:221
Definition: linear_weights.hpp:8
int size() const
Definition: grid_field.hpp:311
int size() const
Definition: grid_field.hpp:266
Kokkos::View< field_type **, Kokkos::LayoutRight, Device > f
Definition: grid_field.hpp:260
Definition: globals.hpp:89
Definition: grid_weights.hpp:47
KOKKOS_INLINE_FUNCTION bool is_allocated() const
Definition: grid_field.hpp:403
GridField(std::string name, int nphi, int nnode)
Definition: grid_field.hpp:397
GridField(std::string name, int nnode)
Definition: grid_field.hpp:35
field_type * data() const
Definition: grid_field.hpp:310
Kokkos::View< double **, Kokkos::LayoutRight, Device, Kokkos::MemoryTraits< Kokkos::Unmanaged > > unmanaged() const
Definition: grid_field.hpp:412
int nphi() const
Definition: grid_field.hpp:40
View< double *, CLayout, Device, Kokkos::MemoryTraits< Kokkos::Unmanaged > > unmanaged() const
Definition: grid_field.hpp:112
GridField< DeviceType, VarType::Vector2D, PhiInterpType::None, TorType::MultiplePlanes, KinType::DriftKin > Efield2DType
Definition: grid_field.hpp:441
int nrhop1() const
Definition: grid_field.hpp:430
GridField()
Definition: grid_field.hpp:425
GridField< DeviceType, VarType::Vector, PhiInterpType::Planes, TorType::MultiplePlanes, KinType::DriftKin > EfieldType
Definition: grid_field.hpp:440
KOKKOS_INLINE_FUNCTION bool is_allocated() const
Definition: grid_field.hpp:315
int nrhop1() const
Definition: grid_field.hpp:401
Kokkos::LayoutRight CLayout
Definition: space_settings.hpp:67
GridField< DeviceType, VarType::Vector2D, PIT_GLOBAL, TorType::OnePlane, KinType::DriftKin > E00Type
Definition: grid_field.hpp:443
void reset_to_zero()
Definition: grid_field.hpp:379
KOKKOS_INLINE_FUNCTION bool is_allocated() const
Definition: grid_field.hpp:432
int size() const
Definition: grid_field.hpp:428
constexpr KOKKOS_INLINE_FUNCTION PhiWtUsage get_phi_wt_usage(PhiInterpType PIT)
Definition: grid_weights.hpp:15
field_type * data() const
Definition: grid_field.hpp:398
GridField(std::string name, int nphi, int nrho, int nnode)
Definition: grid_field.hpp:308
Definition: grid_field.hpp:22
KOKKOS_INLINE_FUNCTION void gather(const Grid< Device > &grid, const SimdGridWeights< Order::One, PhiInterpType::Planes > &grid_wts, const Simd< double > &phi, Simd< double > &fld) const
Definition: grid_field.hpp:80
GridField< DeviceType, VarType::Scalar, PIT_GLOBAL, TorType::OnePlane, KinType::DriftKin > AxisymPotType
Definition: grid_field.hpp:439
KOKKOS_INLINE_FUNCTION void scatter(const Grid< DeviceType > &grid, int ithread, const SimdGridWeights< Order::One, PIT_GLOBAL > &grid_wts, int i_simd, const SimdGyroWeights< DriftKin > &rho_wts, double particle_weight) const
Definition: grid_field.hpp:51
field_type * data() const
Definition: grid_field.hpp:36
Definition: grid_weights.hpp:18
void reset_to_zero()
Definition: grid_field.hpp:96
TorType
Definition: grid_field.hpp:14
int nphi() const
Definition: grid_field.hpp:269
Definition: gyro_radius.hpp:114
KOKKOS_INLINE_FUNCTION void scatter(const Grid< DeviceType > &grid, int ithread, const SimdGridWeights< Order::One, PIT_GLOBAL > &grid_wts, int i_simd, const SimdGyroWeights< GyroKin > &rho_wts, double particle_weight) const
Definition: grid_field.hpp:280
int size() const
Definition: grid_field.hpp:354
GridField()
Definition: grid_field.hpp:33
Definition: gyro_radius.hpp:84
int nrhop1() const
Definition: grid_field.hpp:268
Kokkos::View< field_type *, Kokkos::LayoutRight, Device > f
Definition: grid_field.hpp:31
Device device_type
Definition: grid_field.hpp:257
KOKKOS_INLINE_FUNCTION void scatter(int ithread, int node, const SimdPhiWeights< get_phi_wt_usage(PIT)> &phi_wts, const SimdGyroWeights< GyroKin > &rho_wts, int i_simd, double particle_weight) const
Definition: grid_field.hpp:362
KOKKOS_INLINE_FUNCTION void access_add(T *addr, T val)
Definition: access_add.hpp:40
KOKKOS_INLINE_FUNCTION void scatter(int node, const SimdPhiWeights< get_phi_wt_usage(PIT)> &phi_wts, int i_simd, double particle_weight) const
Definition: grid_field.hpp:46
static KOKKOS_INLINE_FUNCTION void view_odim_variance(const Grid< DeviceType > &grid, const View< double **, CLayout, Device > &view, const View< double **, CLayout, Device > &variance, int ind, const SimdGridWeights< Order::One, PIT_GLOBAL > &grid_wts, double val, int i_simd)
Definition: grid_field.hpp:231
void grid_field_copy(T &dest, const T &src)
Definition: grid_field.hpp:452
void transpose_copy_from_double_view(const View< double **, CLayout, Device > &src_view) const
Definition: grid_field.hpp:135
KOKKOS_INLINE_FUNCTION int get_node_index(int triangle_index, int tri_vertex_index) const
Definition: grid.tpp:158
GridField(std::string name, int nphi, int nrho, int nnode)
Definition: grid_field.hpp:263
KOKKOS_INLINE_FUNCTION void scatter(int ithread, int node, const SimdPhiWeights< get_phi_wt_usage(PIT)> &phi_wts, int i_simd, double particle_weight) const
Definition: grid_field.hpp:319
double w[2]
Definition: linear_weights.hpp:10
Device device_type
Definition: grid_field.hpp:302
Definition: globals.hpp:90
GridField< DeviceType, VarType::Scalar, PhiInterpType::None, TorType::OnePlane, KinType::DriftKin > ScalarGridField
Definition: grid_field.hpp:437
GridField< Device, VT, PIT, TorType::OnePlane, KinType::DriftKin > subfield(int subfield_idx) const
Definition: grid_field.hpp:406
static KOKKOS_INLINE_FUNCTION void view_vec_odim_gather(const Grid< DeviceType > &grid, const View< Field< VarType::Vector, PhiInterpType::None > **, CLayout, Device > &view, int ind, const SimdGridWeights< Order::One, PhiInterpType::None > &grid_wts, SimdVector &val, int i_simd)
Definition: grid_field.hpp:176
static KOKKOS_INLINE_FUNCTION void view_scatter(const Grid< DeviceType > &grid, const View< double *, CLayout, Device > &view, const SimdGridWeights< Order::One, PhiInterpType::None > &grid_wts, double val, int i_simd)
Definition: grid_field.hpp:212
GridField()
Definition: grid_field.hpp:395
Simd< double > phi
Definition: simd.hpp:152
field_type * data() const
Definition: grid_field.hpp:265
int nrhop1() const
Definition: grid_field.hpp:39
KOKKOS_INLINE_FUNCTION void gather(const Grid< Device > &grid, const SimdGridWeights< Order::One, PhiInterpType::None > &grid_wts, const Simd< double > &phi, Simd< double > &fld) const
Definition: grid_field.hpp:63
Simd< double > z
Definition: simd.hpp:151
int i
Definition: linear_weights.hpp:9
KinType
Definition: globals.hpp:88
Kokkos::View< field_type ***, Kokkos::LayoutRight, Device > f
Definition: grid_field.hpp:423
Device device_type
Definition: grid_field.hpp:28
GridField< DeviceType, VarType::Vector2D, PIT_GLOBAL, TorType::OnePlane, KinType::GyroKin > E00GyroType
Definition: grid_field.hpp:447
field_type * data() const
Definition: grid_field.hpp:427
int nphi() const
Definition: grid_field.hpp:314
int nphi() const
Definition: grid_field.hpp:402
field_type * data() const
Definition: grid_field.hpp:353
int nnode() const
Definition: grid_field.hpp:267
GridField()
Definition: grid_field.hpp:307
Kokkos::View< field_type **, Kokkos::LayoutRight, Device > f
Definition: grid_field.hpp:305
Kokkos::View< T *, Kokkos::LayoutRight, Device > my_subview(const Kokkos::View< T ****, Kokkos::LayoutRight, Device > &view, int i, int j, int k)
Definition: my_subview.hpp:8
GridField< DeviceType, VarType::Scalar, PIT_GLOBAL, TorType::OnePlane, KinType::GyroKin > PotGyroType
Definition: grid_field.hpp:446
KOKKOS_INLINE_FUNCTION void scatter(int node, const SimdPhiWeights< get_phi_wt_usage(PIT)> &phi_wts, const SimdGyroWeights< GyroKin > &rho_wts, int i_simd, double particle_weight) const
Definition: grid_field.hpp:274
Device device_type
Definition: grid_field.hpp:420
int nrhop1() const
Definition: grid_field.hpp:356
int nnode() const
Definition: grid_field.hpp:400
KOKKOS_INLINE_FUNCTION bool is_allocated() const
Definition: grid_field.hpp:358
int get_num_cpu_threads()
Definition: globals.hpp:17
Kokkos::View< field_type ***, Kokkos::LayoutRight, Device > f
Definition: grid_field.hpp:348
GridField(std::string name, int nphi, int nrho, int nnode)
Definition: grid_field.hpp:426
static KOKKOS_INLINE_FUNCTION void view_gather(const Grid< DeviceType > &grid, const View< double *, CLayout, Device > &view, const SimdGridWeights< Order::One, PIT_GLOBAL > &grid_wts, Simd< double > &val)
Definition: grid_field.hpp:165
int nnode() const
Definition: grid_field.hpp:312
GridField()
Definition: grid_field.hpp:262
void reset_to_zero()
Definition: grid_field.hpp:335
void parallel_for(const std::string name, int n_ptl, Function func, Option option, HostAoSoA aosoa_h, DeviceAoSoA aosoa_d)
Definition: streamed_parallel_for.hpp:252
int nnode() const
Definition: grid_field.hpp:38
GridField< DeviceType, VarType::Scalar, PIT_GLOBAL, TorType::OnePlane, KinType::DriftKin > OnePlanePotType
Definition: grid_field.hpp:438
KOKKOS_INLINE_FUNCTION void scatter(const Grid< DeviceType > &grid, int ithread, const SimdGridWeights< Order::One, PIT_GLOBAL > &grid_wts, int i_simd, const SimdGyroWeights< GyroKin > &rho_wts, double particle_weight) const
Definition: grid_field.hpp:368
GridField< DeviceType, VarType::Vector, PhiInterpType::Planes, TorType::OnePlane, KinType::GyroKin > EfieldGyroType
Definition: grid_field.hpp:444
Kokkos::View< field_type **, Kokkos::LayoutRight, Device > f
Definition: grid_field.hpp:393
int nrhop1() const
Definition: grid_field.hpp:313
GridField()
Definition: grid_field.hpp:350
GridField(std::string name, int nphi, int nrho, int nnode)
Definition: grid_field.hpp:351
static KOKKOS_INLINE_FUNCTION void view_rep_scatter3(const Grid< DeviceType > &grid, const View< double ***, CLayout, Device > &view, int ind1, int ind2, int ind3, const SimdGridWeights< Order::One, PIT_GLOBAL > &grid_wts, double val1, double val2, double val3, int ithread, int i_simd)
Definition: grid_field.hpp:241
int nnode() const
Definition: grid_field.hpp:429
void reset_to_zero()
Definition: grid_field.hpp:291
int nphi() const
Definition: grid_field.hpp:431
GridField(std::string name, int nnode)
Definition: grid_field.hpp:309