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);
190 val.
phi[i_simd] = 0.0;
191 int node = grid_wts.node[i_simd];
192 constexpr
double wp = 1.0;
193 view(ind,node).gather(val, i_simd, wp);
196 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){
198 for (
int ip = 0; ip < 3; ip++){
200 Kokkos::atomic_add(&(view1(rho_wts.
i, node)), grid_wts.p[ip][i_simd]*rho_wts.
w[0]*val1);
201 Kokkos::atomic_add(&(view2(rho_wts.
i, node)), grid_wts.p[ip][i_simd]*rho_wts.
w[0]*val2);
202 Kokkos::atomic_add(&(view3(rho_wts.
i, node)), grid_wts.p[ip][i_simd]*rho_wts.
w[0]*val3);
204 Kokkos::atomic_add(&(view1(rho_wts.
i+1, node)), grid_wts.p[ip][i_simd]*rho_wts.
w[1]*val1);
205 Kokkos::atomic_add(&(view2(rho_wts.
i+1, node)), grid_wts.p[ip][i_simd]*rho_wts.
w[1]*val2);
206 Kokkos::atomic_add(&(view3(rho_wts.
i+1, node)), grid_wts.p[ip][i_simd]*rho_wts.
w[1]*val3);
213 for (
int j = 0; j<3; j++){
215 double wp=grid_wts.p[j][i_simd];
217 Kokkos::atomic_add(&(view(ind,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(node)), wp*val);
231 for (
int j = 0; j<3; j++){
233 double wp=grid_wts.p[j][i_simd];
235 Kokkos::atomic_add(&(view(0,node)), wp*wphi*val);
236 Kokkos::atomic_add(&(view(1,node)), wp*(1.0-wphi)*val);
240 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){
241 for (
int j = 0; j<3; j++){
243 double wp=grid_wts.p[j][i_simd];
245 double tmp = view(ind,node) - wp*val;
246 Kokkos::atomic_add(&(variance(ind,node)), tmp*tmp);
250 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){
252 for (
int ip = 0; ip < 3; ip++){
254 double wp = grid_wts.p[ip][i_simd];
256 access_add(&(view(ithread,node,ind1)),wp*val1);
257 access_add(&(view(ithread,node,ind2)),wp*val2);
258 access_add(&(view(ithread,node,ind3)),wp*val3);
263 template<
class Device, VarType VT, PhiInterpType PIT>
269 Kokkos::View<field_type**,Kokkos::LayoutRight,Device>
f;
272 GridField(std::string name,
int nphi,
int nrho,
int nnode) : f(name,nnode, nrho+1) {}
273 GridField(std::string name,
int nrho,
int nnode) : f(name,nnode, nrho+1) {}
275 int size()
const {
return f.size();}
276 int nnode()
const {
return f.extent(0);}
279 KOKKOS_INLINE_FUNCTION
bool is_allocated()
const {
return f.is_allocated();}
280 KOKKOS_INLINE_FUNCTION
field_type& operator ()(
int inode,
int irho)
const {
return f(inode, irho);}
284 int irho = rho_wts.
irho(i_simd);
285 f(node,irho).scatter(rho_wts, phi_wts, i_simd, particle_weight, f(node,irho+1));
290 for (
int j = 0; j<3; j++){
293 double wp=grid_wts.p[j][i_simd];
296 scatter(node, grid_wts.phi_wts, rho_wts, i_simd, wp*particle_weight);
301 int ndoubles_in_grid_field = f.size()*field_type::SIZE();
302 Kokkos::View<double*,Kokkos::LayoutRight,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>> view_1d_double((
double*)(f.data()), ndoubles_in_grid_field);
303 Kokkos::deep_copy(view_1d_double, 0.0);
308 template<
class Device, VarType VT, PhiInterpType PIT>
314 Kokkos::View<field_type**,Kokkos::LayoutRight,Device>
f;
320 int size()
const {
return f.size();}
321 int nnode()
const {
return f.extent(1);}
324 KOKKOS_INLINE_FUNCTION
bool is_allocated()
const {
return f.is_allocated();}
325 KOKKOS_INLINE_FUNCTION
field_type& operator ()(
int ithread,
int inode)
const {
return f(ithread, inode);}
329 f(ithread,node).scatter(phi_wts, i_simd, particle_weight);
334 for (
int j = 0; j<3; j++){
337 double wp=grid_wts.p[j][i_simd];
340 scatter(ithread, node, grid_wts.phi_wts, i_simd, wp*particle_weight);
345 int ndoubles_in_grid_field = f.size()*field_type::SIZE();
346 Kokkos::View<double*,Kokkos::LayoutRight,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>> view_1d_double((
double*)(f.data()), ndoubles_in_grid_field);
347 Kokkos::deep_copy(view_1d_double, 0.0);
351 template<
class Device, VarType VT, PhiInterpType PIT>
357 Kokkos::View<field_type***,Kokkos::LayoutRight,Device>
f;
363 int size()
const {
return f.size();}
364 int nnode()
const {
return f.extent(1);}
367 KOKKOS_INLINE_FUNCTION
bool is_allocated()
const {
return f.is_allocated();}
368 KOKKOS_INLINE_FUNCTION
field_type& operator ()(
int ithread,
int inode,
int irho)
const {
return f(ithread,inode, irho);}
372 int irho = rho_wts.
irho(i_simd);
373 f(ithread,node,irho).scatter(rho_wts, phi_wts, i_simd, particle_weight, f(ithread,node,irho+1));
378 for (
int j = 0; j<3; j++){
381 double wp=grid_wts.p[j][i_simd];
384 scatter(ithread, node, grid_wts.phi_wts, rho_wts, i_simd, wp*particle_weight);
389 int ndoubles_in_grid_field = f.size()*field_type::SIZE();
390 Kokkos::View<double*,Kokkos::LayoutRight,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>> view_1d_double((
double*)(f.data()), ndoubles_in_grid_field);
391 Kokkos::deep_copy(view_1d_double, 0.0);
396 template<
class Device, VarType VT, PhiInterpType PIT>
402 Kokkos::View<field_type**,Kokkos::LayoutRight,Device>
f;
405 GridField(std::string name,
int nphi,
int nrho,
int nnode) : f(name,nphi, nnode) {}
406 GridField(std::string name,
int nphi,
int nnode) : f(name,nphi, nnode) {}
408 int size()
const {
return f.size();}
409 int nnode()
const {
return f.extent(1);}
411 int nphi()
const {
return f.extent(0);}
412 KOKKOS_INLINE_FUNCTION
bool is_allocated()
const {
return f.is_allocated();}
413 KOKKOS_INLINE_FUNCTION
field_type& operator ()(
int iphi,
int inode)
const {
return f(iphi, inode);}
421 Kokkos::View<double**,Kokkos::LayoutRight,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>>
unmanaged()
const{
422 return Kokkos::View<double**,Kokkos::LayoutRight,Device,Kokkos::MemoryTraits<Kokkos::Unmanaged>>((
double*)(f.data()), f.layout());
426 template<
class Device, VarType VT, PhiInterpType PIT>
432 Kokkos::View<field_type***,Kokkos::LayoutRight,Device>
f;
435 GridField(std::string name,
int nphi,
int nrho,
int nnode) : f(name,nphi, nnode, nrho+1) {}
437 int size()
const {
return f.size();}
438 int nnode()
const {
return f.extent(1);}
440 int nphi()
const {
return f.extent(0);}
441 KOKKOS_INLINE_FUNCTION
bool is_allocated()
const {
return f.is_allocated();}
442 KOKKOS_INLINE_FUNCTION
field_type& operator ()(
int iphi,
int inode,
int irho)
const {
return f(iphi, inode, irho);}
466 template<
typename T1,
typename T2>
469 dest = T1(
"grid_field",src.nphi(), src.nrhop1()-1, src.nnode());
471 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:212
GridField< DeviceType, VarType::Vector2D, PhiInterpType::None, TorType::OnePlane, KinType::GyroKin > Efield2DGyroType
Definition: grid_field.hpp:454
Simd< double > r
Definition: simd.hpp:150
int size() const
Definition: grid_field.hpp:408
GridField(std::string name, int nphi, int nrho, int nnode)
Definition: grid_field.hpp:34
Device device_type
Definition: grid_field.hpp:354
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:399
int nnode() const
Definition: grid_field.hpp:364
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:333
GridField(std::string name, int nphi, int nrho, int nnode)
Definition: grid_field.hpp:405
int nphi() const
Definition: grid_field.hpp:366
GridField< DeviceType, VarType::Scalar, PIT_GLOBAL, TorType::MultiplePlanes, KinType::DriftKin > PotType
Definition: grid_field.hpp:451
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:273
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:109
KOKKOS_INLINE_FUNCTION bool is_allocated() const
Definition: grid_field.hpp:279
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:196
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:361
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:230
Definition: linear_weights.hpp:8
int size() const
Definition: grid_field.hpp:320
int size() const
Definition: grid_field.hpp:275
Kokkos::View< field_type **, Kokkos::LayoutRight, Device > f
Definition: grid_field.hpp:269
Definition: globals.hpp:89
Definition: grid_weights.hpp:47
KOKKOS_INLINE_FUNCTION bool is_allocated() const
Definition: grid_field.hpp:412
GridField(std::string name, int nphi, int nnode)
Definition: grid_field.hpp:406
GridField(std::string name, int nnode)
Definition: grid_field.hpp:35
field_type * data() const
Definition: grid_field.hpp:319
Kokkos::View< double **, Kokkos::LayoutRight, Device, Kokkos::MemoryTraits< Kokkos::Unmanaged > > unmanaged() const
Definition: grid_field.hpp:421
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:450
int nrhop1() const
Definition: grid_field.hpp:439
GridField()
Definition: grid_field.hpp:434
GridField< DeviceType, VarType::Vector, PhiInterpType::Planes, TorType::MultiplePlanes, KinType::DriftKin > EfieldType
Definition: grid_field.hpp:449
KOKKOS_INLINE_FUNCTION bool is_allocated() const
Definition: grid_field.hpp:324
int nrhop1() const
Definition: grid_field.hpp:410
Kokkos::LayoutRight CLayout
Definition: space_settings.hpp:68
GridField< DeviceType, VarType::Vector2D, PIT_GLOBAL, TorType::OnePlane, KinType::DriftKin > E00Type
Definition: grid_field.hpp:452
void reset_to_zero()
Definition: grid_field.hpp:388
KOKKOS_INLINE_FUNCTION bool is_allocated() const
Definition: grid_field.hpp:441
int size() const
Definition: grid_field.hpp:437
constexpr KOKKOS_INLINE_FUNCTION PhiWtUsage get_phi_wt_usage(PhiInterpType PIT)
Definition: grid_weights.hpp:15
field_type * data() const
Definition: grid_field.hpp:407
GridField(std::string name, int nphi, int nrho, int nnode)
Definition: grid_field.hpp:317
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:448
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:278
Definition: gyro_radius.hpp:116
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:289
int size() const
Definition: grid_field.hpp:363
GridField()
Definition: grid_field.hpp:33
Definition: gyro_radius.hpp:84
int nrhop1() const
Definition: grid_field.hpp:277
Kokkos::View< field_type *, Kokkos::LayoutRight, Device > f
Definition: grid_field.hpp:31
Device device_type
Definition: grid_field.hpp:266
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:371
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:240
void grid_field_copy(T &dest, const T &src)
Definition: grid_field.hpp:461
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:272
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:328
double w[2]
Definition: linear_weights.hpp:10
Device device_type
Definition: grid_field.hpp:311
Definition: globals.hpp:90
GridField< DeviceType, VarType::Scalar, PhiInterpType::None, TorType::OnePlane, KinType::DriftKin > ScalarGridField
Definition: grid_field.hpp:446
GridField< Device, VT, PIT, TorType::OnePlane, KinType::DriftKin > subfield(int subfield_idx) const
Definition: grid_field.hpp:415
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:221
GridField()
Definition: grid_field.hpp:404
Simd< double > phi
Definition: simd.hpp:152
field_type * data() const
Definition: grid_field.hpp:274
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:432
Device device_type
Definition: grid_field.hpp:28
GridField< DeviceType, VarType::Vector2D, PIT_GLOBAL, TorType::OnePlane, KinType::GyroKin > E00GyroType
Definition: grid_field.hpp:456
field_type * data() const
Definition: grid_field.hpp:436
int nphi() const
Definition: grid_field.hpp:323
int nphi() const
Definition: grid_field.hpp:411
field_type * data() const
Definition: grid_field.hpp:362
int nnode() const
Definition: grid_field.hpp:276
GridField()
Definition: grid_field.hpp:316
Kokkos::View< field_type **, Kokkos::LayoutRight, Device > f
Definition: grid_field.hpp:314
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:455
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:283
Device device_type
Definition: grid_field.hpp:429
int nrhop1() const
Definition: grid_field.hpp:365
int nnode() const
Definition: grid_field.hpp:409
KOKKOS_INLINE_FUNCTION bool is_allocated() const
Definition: grid_field.hpp:367
int get_num_cpu_threads()
Definition: globals.hpp:17
Kokkos::View< field_type ***, Kokkos::LayoutRight, Device > f
Definition: grid_field.hpp:357
GridField(std::string name, int nphi, int nrho, int nnode)
Definition: grid_field.hpp:435
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:321
GridField()
Definition: grid_field.hpp:271
void reset_to_zero()
Definition: grid_field.hpp:344
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:447
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:377
GridField< DeviceType, VarType::Vector, PhiInterpType::Planes, TorType::OnePlane, KinType::GyroKin > EfieldGyroType
Definition: grid_field.hpp:453
Kokkos::View< field_type **, Kokkos::LayoutRight, Device > f
Definition: grid_field.hpp:402
int nrhop1() const
Definition: grid_field.hpp:322
GridField()
Definition: grid_field.hpp:359
GridField(std::string name, int nphi, int nrho, int nnode)
Definition: grid_field.hpp:360
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:250
int nnode() const
Definition: grid_field.hpp:438
void reset_to_zero()
Definition: grid_field.hpp:300
int nphi() const
Definition: grid_field.hpp:440
GridField(std::string name, int nnode)
Definition: grid_field.hpp:318
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::Zero, PhiInterpType::None > &grid_wts, SimdVector &val, int i_simd)
Definition: grid_field.hpp:187