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);
116 constexpr
int n_phi = field_type::NPHI();
119 View<double**,CLayout,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>> f_unmanaged((
double*)data(),nnode(), n_phi);
122 Kokkos::parallel_for(
"var_transpose_copy", Kokkos::RangePolicy<typename Device::execution_space>( 0, nnode()), KOKKOS_LAMBDA(
const int inode){
123 for(
int iphi=0; iphi<n_phi; iphi++){
124 dest_view(iphi, inode) = f_unmanaged(inode, iphi);
133 constexpr
int n_phi = field_type::NPHI();
136 View<double**,CLayout,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>> f_unmanaged((
double*)data(),nnode(), n_phi);
139 Kokkos::parallel_for(
"var_transpose_copy", Kokkos::RangePolicy<ExSpace>( 0, nnode()), KOKKOS_LAMBDA(
const int inode){
140 for(
int iphi=0; iphi<n_phi; iphi++){
141 f_unmanaged(inode, iphi) = src_view(iphi, inode);
149 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){
153 for (
int ip=0; ip<3; ip++){
155 val1 += view1(nd)*grid_wts.p[ip][i_simd];
156 val2 += view2(nd)*grid_wts.p[ip][i_simd];
157 val3 += view3(nd)*grid_wts.p[ip][i_simd];
163 for (
int i_simd = 0; i_simd<SIMD_SIZE; i_simd++){
164 if(grid_wts.itr[i_simd]<=0)
continue;
165 for (
int ip = 0; ip < 3; ip++){
167 val[i_simd] += grid_wts.p[ip][i_simd]*view(node);
175 val.
phi[i_simd] = 0.0;
176 for (
int ip = 0; ip<3; ip++){
178 double wp = grid_wts.p[ip][i_simd];
179 view(ind,node).gather(val, i_simd, wp);
183 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){
185 for (
int ip = 0; ip < 3; ip++){
187 Kokkos::atomic_add(&(view1(rho_wts.
i, node)), grid_wts.p[ip][i_simd]*rho_wts.
w[0]*val1);
188 Kokkos::atomic_add(&(view2(rho_wts.
i, node)), grid_wts.p[ip][i_simd]*rho_wts.
w[0]*val2);
189 Kokkos::atomic_add(&(view3(rho_wts.
i, node)), grid_wts.p[ip][i_simd]*rho_wts.
w[0]*val3);
191 Kokkos::atomic_add(&(view1(rho_wts.
i+1, node)), grid_wts.p[ip][i_simd]*rho_wts.
w[1]*val1);
192 Kokkos::atomic_add(&(view2(rho_wts.
i+1, node)), grid_wts.p[ip][i_simd]*rho_wts.
w[1]*val2);
193 Kokkos::atomic_add(&(view3(rho_wts.
i+1, node)), grid_wts.p[ip][i_simd]*rho_wts.
w[1]*val3);
200 for (
int j = 0; j<3; j++){
202 double wp=grid_wts.p[j][i_simd];
204 Kokkos::atomic_add(&(view(ind,node)), wp*val);
209 for (
int j = 0; j<3; j++){
211 double wp=grid_wts.p[j][i_simd];
213 Kokkos::atomic_add(&(view(node)), wp*val);
218 for (
int j = 0; j<3; j++){
220 double wp=grid_wts.p[j][i_simd];
222 Kokkos::atomic_add(&(view(0,node)), wp*wphi*val);
223 Kokkos::atomic_add(&(view(1,node)), wp*(1.0-wphi)*val);
227 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){
228 for (
int j = 0; j<3; j++){
230 double wp=grid_wts.p[j][i_simd];
232 double tmp = view(ind,node) - wp*val;
233 Kokkos::atomic_add(&(variance(ind,node)), tmp*tmp);
237 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){
239 for (
int ip = 0; ip < 3; ip++){
241 double wp = grid_wts.p[ip][i_simd];
243 access_add(&(view(ithread,node,ind1)),wp*val1);
244 access_add(&(view(ithread,node,ind2)),wp*val2);
245 access_add(&(view(ithread,node,ind3)),wp*val3);
250 template<
class Device, VarType VT, PhiInterpType PIT>
256 Kokkos::View<field_type**,Kokkos::LayoutRight,Device>
f;
259 GridField(std::string name,
int nphi,
int nrho,
int nnode) : f(name,nnode, nrho+1) {}
260 GridField(std::string name,
int nrho,
int nnode) : f(name,nnode, nrho+1) {}
262 int size()
const {
return f.size();}
263 int nnode()
const {
return f.extent(0);}
266 KOKKOS_INLINE_FUNCTION
bool is_allocated()
const {
return f.is_allocated();}
267 KOKKOS_INLINE_FUNCTION
field_type& operator ()(
int inode,
int irho)
const {
return f(inode, irho);}
271 int irho = rho_wts.
irho(i_simd);
272 f(node,irho).scatter(rho_wts, phi_wts, i_simd, particle_weight, f(node,irho+1));
277 for (
int j = 0; j<3; j++){
280 double wp=grid_wts.p[j][i_simd];
283 scatter(node, grid_wts.phi_wts, rho_wts, i_simd, wp*particle_weight);
288 int ndoubles_in_grid_field = f.size()*field_type::SIZE();
289 Kokkos::View<double*,Kokkos::LayoutRight,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>> view_1d_double((
double*)(f.data()), ndoubles_in_grid_field);
290 Kokkos::deep_copy(view_1d_double, 0.0);
295 template<
class Device, VarType VT, PhiInterpType PIT>
301 Kokkos::View<field_type**,Kokkos::LayoutRight,Device>
f;
307 int size()
const {
return f.size();}
308 int nnode()
const {
return f.extent(1);}
311 KOKKOS_INLINE_FUNCTION
bool is_allocated()
const {
return f.is_allocated();}
312 KOKKOS_INLINE_FUNCTION
field_type& operator ()(
int ithread,
int inode)
const {
return f(ithread, inode);}
316 f(ithread,node).scatter(phi_wts, i_simd, particle_weight);
321 for (
int j = 0; j<3; j++){
324 double wp=grid_wts.p[j][i_simd];
327 scatter(ithread, node, grid_wts.phi_wts, i_simd, wp*particle_weight);
332 int ndoubles_in_grid_field = f.size()*field_type::SIZE();
333 Kokkos::View<double*,Kokkos::LayoutRight,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>> view_1d_double((
double*)(f.data()), ndoubles_in_grid_field);
334 Kokkos::deep_copy(view_1d_double, 0.0);
338 template<
class Device, VarType VT, PhiInterpType PIT>
344 Kokkos::View<field_type***,Kokkos::LayoutRight,Device>
f;
350 int size()
const {
return f.size();}
351 int nnode()
const {
return f.extent(1);}
354 KOKKOS_INLINE_FUNCTION
bool is_allocated()
const {
return f.is_allocated();}
355 KOKKOS_INLINE_FUNCTION
field_type& operator ()(
int ithread,
int inode,
int irho)
const {
return f(ithread,inode, irho);}
359 int irho = rho_wts.
irho(i_simd);
360 f(ithread,node,irho).scatter(rho_wts, phi_wts, i_simd, particle_weight, f(ithread,node,irho+1));
365 for (
int j = 0; j<3; j++){
368 double wp=grid_wts.p[j][i_simd];
371 scatter(ithread, node, grid_wts.phi_wts, rho_wts, i_simd, wp*particle_weight);
376 int ndoubles_in_grid_field = f.size()*field_type::SIZE();
377 Kokkos::View<double*,Kokkos::LayoutRight,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>> view_1d_double((
double*)(f.data()), ndoubles_in_grid_field);
378 Kokkos::deep_copy(view_1d_double, 0.0);
383 template<
class Device, VarType VT, PhiInterpType PIT>
389 Kokkos::View<field_type**,Kokkos::LayoutRight,Device>
f;
392 GridField(std::string name,
int nphi,
int nrho,
int nnode) : f(name,nphi, nnode) {}
393 GridField(std::string name,
int nphi,
int nnode) : f(name,nphi, nnode) {}
395 int size()
const {
return f.size();}
396 int nnode()
const {
return f.extent(1);}
398 int nphi()
const {
return f.extent(0);}
399 KOKKOS_INLINE_FUNCTION
bool is_allocated()
const {
return f.is_allocated();}
400 KOKKOS_INLINE_FUNCTION
field_type& operator ()(
int iphi,
int inode)
const {
return f(iphi, inode);}
408 Kokkos::View<double**,Kokkos::LayoutRight,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>>
unmanaged()
const{
409 return Kokkos::View<double**,Kokkos::LayoutRight,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>>((
double*)(f.data()), f.layout());
413 template<
class Device, VarType VT, PhiInterpType PIT>
419 Kokkos::View<field_type***,Kokkos::LayoutRight,Device>
f;
422 GridField(std::string name,
int nphi,
int nrho,
int nnode) : f(name,nphi, nnode, nrho+1) {}
424 int size()
const {
return f.size();}
425 int nnode()
const {
return f.extent(1);}
427 int nphi()
const {
return f.extent(0);}
428 KOKKOS_INLINE_FUNCTION
bool is_allocated()
const {
return f.is_allocated();}
429 KOKKOS_INLINE_FUNCTION
field_type& operator ()(
int iphi,
int inode,
int irho)
const {
return f(iphi, inode, irho);}
453 template<
typename T1,
typename T2>
456 dest = T1(
"grid_field",src.nphi(), src.nrhop1()-1, src.nnode());
458 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:199
GridField< DeviceType, VarType::Vector2D, PhiInterpType::None, TorType::OnePlane, KinType::GyroKin > Efield2DGyroType
Definition: grid_field.hpp:441
Simd< double > r
Definition: simd.hpp:150
int size() const
Definition: grid_field.hpp:395
GridField(std::string name, int nphi, int nrho, int nnode)
Definition: grid_field.hpp:34
Device device_type
Definition: grid_field.hpp:341
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:149
Device device_type
Definition: grid_field.hpp:386
int nnode() const
Definition: grid_field.hpp:351
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:320
GridField(std::string name, int nphi, int nrho, int nnode)
Definition: grid_field.hpp:392
int nphi() const
Definition: grid_field.hpp:353
GridField< DeviceType, VarType::Scalar, PIT_GLOBAL, TorType::MultiplePlanes, KinType::DriftKin > PotType
Definition: grid_field.hpp:438
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:260
void transpose_copy_to_double_view(const View< double **, CLayout, Device > &dest_view) const
Definition: grid_field.hpp:114
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:266
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:183
GridField(std::string name, int nrho, int nnode)
Definition: grid_field.hpp:348
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:217
Definition: linear_weights.hpp:8
int size() const
Definition: grid_field.hpp:307
int size() const
Definition: grid_field.hpp:262
Kokkos::View< field_type **, Kokkos::LayoutRight, Device > f
Definition: grid_field.hpp:256
Definition: globals.hpp:89
Definition: grid_weights.hpp:47
KOKKOS_INLINE_FUNCTION bool is_allocated() const
Definition: grid_field.hpp:399
GridField(std::string name, int nphi, int nnode)
Definition: grid_field.hpp:393
GridField(std::string name, int nnode)
Definition: grid_field.hpp:35
field_type * data() const
Definition: grid_field.hpp:306
Kokkos::View< double **, Kokkos::LayoutRight, Device, Kokkos::MemoryTraits< Kokkos::Unmanaged > > unmanaged() const
Definition: grid_field.hpp:408
int nphi() const
Definition: grid_field.hpp:40
void scatter(const Simulation< DeviceType > &sml, const Grid< DeviceType > &grid, const MagneticField< DeviceType > &magnetic_field, const GridFieldPack< DeviceType, PIT > &gfpack, const Species< DeviceType > &species, const Charge< DeviceType, KT > &charge)
Definition: scatter.cpp:234
GridField< DeviceType, VarType::Vector2D, PhiInterpType::None, TorType::MultiplePlanes, KinType::DriftKin > Efield2DType
Definition: grid_field.hpp:437
int nrhop1() const
Definition: grid_field.hpp:426
GridField()
Definition: grid_field.hpp:421
GridField< DeviceType, VarType::Vector, PhiInterpType::Planes, TorType::MultiplePlanes, KinType::DriftKin > EfieldType
Definition: grid_field.hpp:436
KOKKOS_INLINE_FUNCTION bool is_allocated() const
Definition: grid_field.hpp:311
int nrhop1() const
Definition: grid_field.hpp:397
Kokkos::LayoutRight CLayout
Definition: space_settings.hpp:67
GridField< DeviceType, VarType::Vector2D, PIT_GLOBAL, TorType::OnePlane, KinType::DriftKin > E00Type
Definition: grid_field.hpp:439
void reset_to_zero()
Definition: grid_field.hpp:375
KOKKOS_INLINE_FUNCTION bool is_allocated() const
Definition: grid_field.hpp:428
int size() const
Definition: grid_field.hpp:424
constexpr KOKKOS_INLINE_FUNCTION PhiWtUsage get_phi_wt_usage(PhiInterpType PIT)
Definition: grid_weights.hpp:15
field_type * data() const
Definition: grid_field.hpp:394
GridField(std::string name, int nphi, int nrho, int nnode)
Definition: grid_field.hpp:304
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:435
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:265
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:276
int size() const
Definition: grid_field.hpp:350
GridField()
Definition: grid_field.hpp:33
Definition: gyro_radius.hpp:84
int nrhop1() const
Definition: grid_field.hpp:264
Kokkos::View< field_type *, Kokkos::LayoutRight, Device > f
Definition: grid_field.hpp:31
Device device_type
Definition: grid_field.hpp:253
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:358
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:227
void grid_field_copy(T &dest, const T &src)
Definition: grid_field.hpp:448
void transpose_copy_from_double_view(const View< double **, CLayout, Device > &src_view) const
Definition: grid_field.hpp:131
KOKKOS_INLINE_FUNCTION int get_node_index(int triangle_index, int tri_vertex_index) const
Definition: grid.tpp:160
GridField(std::string name, int nphi, int nrho, int nnode)
Definition: grid_field.hpp:259
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:315
double w[2]
Definition: linear_weights.hpp:10
Device device_type
Definition: grid_field.hpp:298
Definition: globals.hpp:90
GridField< DeviceType, VarType::Scalar, PhiInterpType::None, TorType::OnePlane, KinType::DriftKin > ScalarGridField
Definition: grid_field.hpp:433
GridField< Device, VT, PIT, TorType::OnePlane, KinType::DriftKin > subfield(int subfield_idx) const
Definition: grid_field.hpp:402
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:172
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:208
GridField()
Definition: grid_field.hpp:391
Simd< double > phi
Definition: simd.hpp:152
field_type * data() const
Definition: grid_field.hpp:261
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:419
Device device_type
Definition: grid_field.hpp:28
GridField< DeviceType, VarType::Vector2D, PIT_GLOBAL, TorType::OnePlane, KinType::GyroKin > E00GyroType
Definition: grid_field.hpp:443
field_type * data() const
Definition: grid_field.hpp:423
int nphi() const
Definition: grid_field.hpp:310
int nphi() const
Definition: grid_field.hpp:398
field_type * data() const
Definition: grid_field.hpp:349
int nnode() const
Definition: grid_field.hpp:263
GridField()
Definition: grid_field.hpp:303
Kokkos::View< field_type **, Kokkos::LayoutRight, Device > f
Definition: grid_field.hpp:301
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:442
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:270
Device device_type
Definition: grid_field.hpp:416
int nrhop1() const
Definition: grid_field.hpp:352
int nnode() const
Definition: grid_field.hpp:396
KOKKOS_INLINE_FUNCTION bool is_allocated() const
Definition: grid_field.hpp:354
int get_num_cpu_threads()
Definition: globals.hpp:17
Kokkos::View< field_type ***, Kokkos::LayoutRight, Device > f
Definition: grid_field.hpp:344
GridField(std::string name, int nphi, int nrho, int nnode)
Definition: grid_field.hpp:422
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:161
int nnode() const
Definition: grid_field.hpp:308
GridField()
Definition: grid_field.hpp:258
void reset_to_zero()
Definition: grid_field.hpp:331
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:434
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:364
GridField< DeviceType, VarType::Vector, PhiInterpType::Planes, TorType::OnePlane, KinType::GyroKin > EfieldGyroType
Definition: grid_field.hpp:440
Kokkos::View< field_type **, Kokkos::LayoutRight, Device > f
Definition: grid_field.hpp:389
int nrhop1() const
Definition: grid_field.hpp:309
GridField()
Definition: grid_field.hpp:346
GridField(std::string name, int nphi, int nrho, int nnode)
Definition: grid_field.hpp:347
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:237
int nnode() const
Definition: grid_field.hpp:425
void reset_to_zero()
Definition: grid_field.hpp:287
int nphi() const
Definition: grid_field.hpp:427
GridField(std::string name, int nnode)
Definition: grid_field.hpp:305