XGC1
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Pages
plane.hpp
Go to the documentation of this file.
1 #ifndef PLANE_HPP
2 #define PLANE_HPP
3 
4 #include "xgc_io.hpp"
5 #include "magnetic_field.hpp"
6 #include "grid_structs.hpp"
7 #include "grid_weights.hpp"
8 #include "grid_files.hpp"
9 #include "guess_table.hpp"
10 #include "uniform_range.hpp"
11 #include "guess_list_1d.hpp"
12 #include "gradient_matrices.hpp"
13 
14 
15 // Plane class
16 template<class Device>
17 class Plane {
18  // This line enables private access between the host and device implementations of this class
19  // i.e. Makes the copy from host to device more straightforward
20  template<class Device2> friend class Plane;
21 
22  public:
23 
24  // Constructor from namelist
25  Plane(NLReader::NamelistReader& nlr, const PlaneFiles& plane_files, const MagneticField<DeviceType>& magnetic_field, double plane_index_dbl, bool use_as_fortran_grid=false);
26 
27  // Default constructor
28  Plane(){}
29 
30  // Create a mirror with a different device type
31  template<class Device2>
32  inline Plane<Device2> mirror() const{
34 
35  m.ntriangle = ntriangle;
36  m.nnode = nnode;
37  m.nplanes = nplanes;
38  m.plane_phi = plane_phi;
40  m.delta_phi = delta_phi;
42 
43  m.psi = my_mirror_view(psi, Device2());
44  mirror_copy(m.psi, psi);
45  m.bfield = my_mirror_view(bfield, Device2());
47  m.basis = my_mirror_view(basis, Device2());
49  m.nodes = my_mirror_view(nodes, Device2());
51  m.mapping = my_mirror_view(mapping, Device2());
53 
54  m.guess = guess.template mirror<Device2>();
55 
56  m.psi_surf = my_mirror_view(psi_surf, Device2());
58  m.psi_surf_h = psi_surf_h; // Shallow copy since this stays on host
62  m.psi_surf2 = my_mirror_view(psi_surf2, Device2());
68 
69  m.psi00 = psi00;
70  m.psi_guess = psi_guess.template mirror<Device2>();
71 
72  m.rgn = my_mirror_view(rgn, Device2());
73  mirror_copy(m.rgn, rgn);
74  m.gx = my_mirror_view(gx, Device2());
75  mirror_copy(m.gx, gx);
76  // This isn't used on GPU right now
77  //m.adj = my_mirror_view(adj, Device2());
78  //mirror_copy(m.adj, adj);
79 
80  m.nwall = nwall;
81  m.wall_nodes = my_mirror_view(wall_nodes, Device2());
85 
87 
88 #ifdef NO_FORTRAN_MODULES
89  m.gradient_matrices_h = gradient_matrices_h;
90 #endif
91 
92  return m;
93  }
94 
95  void setup_1d_flux_surface_grid(const PlaneFiles& plane_files, const MagneticField<DeviceType>& magnetic_field, const View<double*,CLayout,HostType>& node_vol_h);
96 
97  KOKKOS_INLINE_FUNCTION void t_coeff(const SimdVector2D &x, const Simd<int>& itr, SimdGridVec &p) const;
98 
99  KOKKOS_INLINE_FUNCTION void t_coeff_mod(const MagneticField<Device> &magnetic_field, const double r, const double z, const double psiin, const int itr, double (&p)[3] ) const;
100 
101  KOKKOS_INLINE_FUNCTION void t_coeff_mod(const MagneticField<Device> &magnetic_field, const SimdVector2D &xy, const Simd<double>& psiin, const Simd<int>& itr, SimdGridVec &p ) const;
102 
103  KOKKOS_INLINE_FUNCTION void search_tr2_no_precheck(const double r, const double z, int& itr, double (&p)[3]) const;
104 
105  KOKKOS_INLINE_FUNCTION void search_tr2( const SimdVector2D &xy, Simd<int>& itr, SimdGridVec &pout ) const;
106 
107  KOKKOS_INLINE_FUNCTION void search_tr_check_guess(const SimdVector2D &x, const Simd<int>& old_itr,Simd<int>& itr,SimdGridVec &p ) const;
108 
109  KOKKOS_INLINE_FUNCTION void psi_search(double psi,double &wp,int &ip) const;
110 
111  KOKKOS_INLINE_FUNCTION void follow_field_to_nearest_midplane(const MagneticField<Device> &magnetic_field, const SimdVector2D &x, const Simd<double>& phi, SimdVector2D &xff) const;
112 
113  KOKKOS_INLINE_FUNCTION void get_grid_weights_ff(const MagneticField<Device> &magnetic_field, const SimdVector &v, const Simd<double>& psi_in,SimdVector2D &xff,SimdGridWeights<Order::One, PhiInterpType::Planes>& grid_wts) const;
114 
115  KOKKOS_INLINE_FUNCTION void get_grid_weights_plane_ff(const MagneticField<Device> &magnetic_field, const SimdVector &v, double phi_plane, SimdGridWeights<Order::One, PhiInterpType::Planes>& grid_wts) const;
116 
117  KOKKOS_INLINE_FUNCTION void get_grid_weights_no_ff(const MagneticField<Device> &magnetic_field, const SimdVector2D &x, const Simd<double>& psi_in,SimdGridWeights<Order::One, PhiInterpType::None>& grid_wts) const;
118 
119  template<PhiInterpType PIT>
120  KOKKOS_INLINE_FUNCTION void nearest_node(const SimdGridWeights<Order::One, PIT>& grid_wts, SimdGridWeights<Order::Zero, PIT>& grid_wts0) const;
121 
122  template<PhiInterpType PIT>
123  KOKKOS_INLINE_FUNCTION void get_grid_weights(const MagneticField<Device> &magnetic_field, const SimdVector &v, const Simd<double>& psi, SimdVector2D &xff,SimdGridWeights<Order::One, PIT>& grid_wts) const;
124 
125  template<PhiInterpType PIT>
126  KOKKOS_INLINE_FUNCTION void get_grid_weights(const MagneticField<Device> &magnetic_field, const SimdVector &v, SimdVector2D &xff, SimdGridWeights<Order::One, PIT>& grid_wts) const;
127 
128  template<PhiInterpType PIT>
129  KOKKOS_INLINE_FUNCTION void get_grid_weights(const MagneticField<Device> &magnetic_field, const SimdVector &v, const Simd<double>& psi_in, SimdGridWeights<Order::Zero, PIT>& grid_wts) const;
130 
131  template<PhiInterpType PIT>
132  KOKKOS_INLINE_FUNCTION void get_grid_weights(const MagneticField<Device> &magnetic_field, const SimdVector &v, const Simd<double>& psi_in, SimdGridWeights<Order::One, PIT>& grid_wts) const;
133 
134  template<PhiInterpType PIT>
135  KOKKOS_INLINE_FUNCTION void get_grid_weights(const MagneticField<Device> &magnetic_field, const SimdVector &v, SimdGridWeights<Order::Zero, PIT>& grid_wts) const;
136 
137  template<PhiInterpType PIT>
138  KOKKOS_INLINE_FUNCTION void get_grid_weights(const MagneticField<Device> &magnetic_field, const SimdVector &v, SimdGridWeights<Order::One, PIT>& grid_wts) const;
139 
140  KOKKOS_INLINE_FUNCTION void get_wall_index(const Simd<bool>& just_left_the_grid,const SimdVector2D &x, const SimdGridWeights<Order::One, PIT_GLOBAL>& grid_wts, Simd<int>& widx) const;
141 
142  KOKKOS_INLINE_FUNCTION void wedge_modulo_phi(Simd<double>& phi_mod) const;
143 
144  KOKKOS_INLINE_FUNCTION double wedge_modulo_phi(double phi) const;
145 
146  KOKKOS_INLINE_FUNCTION bool node_is_inside_psi_range(const MagneticField<Device> &magnetic_field, const int node) const;
147 
148  KOKKOS_INLINE_FUNCTION int get_plane_index(double phi) const;
149 
150  KOKKOS_INLINE_FUNCTION int get_node_index(int triangle_index, int tri_vertex_index) const;
151 
152  KOKKOS_INLINE_FUNCTION double node_area_to_volume(const MagneticField<Device> &magnetic_field, double area, int node_index) const;
153 
154  KOKKOS_INLINE_FUNCTION void get_triangle_area_and_volume(const MagneticField<Device> &magnetic_field, int i, double& area, double& volume) const;
155 
156  KOKKOS_INLINE_FUNCTION double get_r_center_of_mass(int itr) const;
157 
158  KOKKOS_INLINE_FUNCTION bool node_is_in_region_1_or_2_no_wall(const int inode) const;
159 
160  KOKKOS_INLINE_FUNCTION bool node_is_in_region_2_or_3_no_wall(const int inode) const;
161 
162  KOKKOS_INLINE_FUNCTION bool node_is_in_private_region_no_wall(const int inode) const;
163 
164  KOKKOS_INLINE_FUNCTION bool node_is_in_included_region(const int inode, const bool exclude_private_region) const;
165 
166  KOKKOS_INLINE_FUNCTION bool node_is_in_region_1_or_2(const MagneticField<Device> &magnetic_field, const int inode) const;
167 
168  template<class Device2>
169  KOKKOS_INLINE_FUNCTION bool node_is_in_region_3b(const MagneticField<Device2> &magnetic_field, const int inode) const;
170 
171  KOKKOS_INLINE_FUNCTION bool node_is_on_wall(const int inode) const;
172 
173  template<class Device2>
174  KOKKOS_INLINE_FUNCTION bool node_is_in_region_3a_no_wall(const MagneticField<Device2> &magnetic_field, const int inode) const;
175 
176  template<class Device2>
177  KOKKOS_INLINE_FUNCTION bool node_is_in_region_3b_no_wall(const MagneticField<Device2> &magnetic_field, const int inode) const;
178 
179  KOKKOS_INLINE_FUNCTION int uses_rz_basis(const int inode) const;
180 
181  KOKKOS_INLINE_FUNCTION double get_r(const int inode) const;
182 
183  KOKKOS_INLINE_FUNCTION double get_dist2_from_node(const int inode, const double r, const double z) const;
184 
185  KOKKOS_INLINE_FUNCTION double get_dist_from_node(const int inode, const double r, const double z) const;
186 
187  KOKKOS_INLINE_FUNCTION void get_rz_coordinates(const int inode, double& r, double& z) const;
188 
189  KOKKOS_INLINE_FUNCTION void get_rz_coordinates(const Simd<int>& grid_inds, SimdVector2D& x) const;
190 
191  KOKKOS_INLINE_FUNCTION void get_rz_coordinates(const int itr, const double (&p)[3], double& r, double& z) const;
192 
193  KOKKOS_INLINE_FUNCTION void get_rz_coordinates(const Simd<int>& itr, const SimdGridVec& p, SimdVector2D& x) const;
194 
195  KOKKOS_INLINE_FUNCTION int get_nearest_node(const Simd<int>& itr, const SimdGridVec& p, int i_simd) const;
196 
197  KOKKOS_INLINE_FUNCTION int get_nearest_node(const int itr, const double (&p)[3]) const;
198 
199  KOKKOS_INLINE_FUNCTION double get_nearest_midplane(double phi) const;
200 
201  KOKKOS_INLINE_FUNCTION void set_gradient_mat_triangle(const View<int*,CLayout,DeviceType>& num_t_node,
202  const View<int**,CLayout,DeviceType>& tr_node, const View<double*,CLayout,DeviceType>& tr_area,
203  const View<double***, CLayout, DeviceType>& unit_vecs,
204  const int i, const GradientMatrices<Device>& gradient_matrices) const;
205 
206  KOKKOS_INLINE_FUNCTION int get_characteristic_length(const View<int*,CLayout,DeviceType>& num_t_node,
207  const View<int**,CLayout,DeviceType>& tr_node, const int i,
208  double& dist_triangle, double& dist_psi, double& dist_theta) const;
209 
210  KOKKOS_INLINE_FUNCTION void set_grad_matrix_from_psi_theta(bool is_psi_dir, int itr_pos, int itr_neg, double (&p_pos)[3], double (&p_neg)[3], double dl_pos, double dl_neg, int inode, const Matrix<Device>& matrix) const;
211 
212  KOKKOS_INLINE_FUNCTION RZPair get_wall_rz(int i_wall) const;
213 
214  void write_to_file(const XGC_IO_Stream& stream, const DomainDecomposition<DeviceType>& pol_decomp, bool is_stellarator, const std::string& prefix) const;
215 
216  void draw_ascii_grid(MagneticField<Device> magnetic_field, double rmin, double rmax, double dr, double zmin, double zmax, double dz){
217  printf("\n\n******** PLOT OF GRID ******* \n");
218  Kokkos::View<int*,HostType> save_vert("save_vert", 1+((rmax-rmin)/dr));
219  for (double zplot = zmax; zplot>=zmin; zplot-=dz){
220  printf("\n");
221  int save_num = 0;
222  int rsave_ind = -1;
223  for (double rplot = rmin; rplot<=rmax; rplot+=dr){
224  rsave_ind++;
225  SimdVector v;
226  v.r = rplot;
227  v.z = zplot;
228  v.phi = 0.001;
229 
230  // Get itr (triangle index)
231  SimdGridVec p;
232  Simd<int> itr = -1;
233  get_grid_weights(magnetic_field, v, itr, p);
234  if(itr[0]!=save_num || itr[0]!=save_vert[rsave_ind]){
235  if(itr[0]<10 && itr[0]>=0) printf("%d ",itr[0]);
236  else printf("%d ",itr[0]);
237  save_num = itr[0];
238  save_vert[rsave_ind] = itr[0];
239  } else {printf(" ");}
240  }
241  }
242  }
243 
244  int ntriangle;
245  int nnode;
246  int nplanes;
247  double plane_phi;
248  double wedge_angle;
249  double delta_phi;
250  double inv_delta_phi;
251 
252  Kokkos::View<double*,Kokkos::LayoutRight,Device> psi;
253  Kokkos::View<double*,Kokkos::LayoutRight,Device> bfield;
254 
255  private:
256  Kokkos::View<int*, Kokkos::LayoutRight,Device> basis;
257  Kokkos::View<Vertex*,Kokkos::LayoutRight,Device> nodes;
258  Kokkos::View<VertexMap*,Kokkos::LayoutRight,Device> mapping;
259  Kokkos::View<int*,Kokkos::LayoutRight,Device> rgn;
260  Kokkos::View<RZPair*,Kokkos::LayoutRight,Device> gx;
262 
263  public:
267  Kokkos::View<double*,Kokkos::LayoutRight,Device> psi_surf;
268  Kokkos::View<double*,Kokkos::LayoutRight,HostType> psi_surf_h;
269  Kokkos::View<double*,Kokkos::LayoutRight,Device> psi_surf2;
270  View<int*, CLayout, Device> psi_map_surf_to_surf2;
271  View<int*, CLayout, Device> psi_map_surf2_to_surf;
273 
274  private:
276 
277  View<int**,CLayout,Device> adj;
278 
279  public:
280  int nwall;
281 
282  //private:
283  Kokkos::View<int*,Kokkos::LayoutRight,Device> wall_nodes;
284  Kokkos::View<int*,Kokkos::LayoutRight,Device> node_to_wall;
285 
287 
288 #ifdef NO_FORTRAN_MODULES
289  GradientMatrices<HostType> gradient_matrices_h;
290 #endif
291 };
292 
293 #include "plane.tpp"
294 #endif
KOKKOS_INLINE_FUNCTION bool node_is_in_private_region_no_wall(const int inode) const
Definition: plane.tpp:763
KOKKOS_INLINE_FUNCTION int get_nearest_node(const Simd< int > &itr, const SimdGridVec &p, int i_simd) const
Definition: plane.tpp:982
double minval_psi_surf2
Definition: plane.hpp:265
KOKKOS_INLINE_FUNCTION int get_plane_index(double phi) const
Definition: plane.tpp:654
Simd< double > r
Definition: simd.hpp:150
Definition: guess_list_1d.hpp:7
KOKKOS_INLINE_FUNCTION void set_gradient_mat_triangle(const View< int *, CLayout, DeviceType > &num_t_node, const View< int **, CLayout, DeviceType > &tr_node, const View< double *, CLayout, DeviceType > &tr_area, const View< double ***, CLayout, DeviceType > &unit_vecs, const int i, const GradientMatrices< Device > &gradient_matrices) const
Definition: plane.tpp:1025
KOKKOS_INLINE_FUNCTION void get_grid_weights_no_ff(const MagneticField< Device > &magnetic_field, const SimdVector2D &x, const Simd< double > &psi_in, SimdGridWeights< Order::One, PhiInterpType::None > &grid_wts) const
Definition: plane.tpp:401
KOKKOS_INLINE_FUNCTION void get_grid_weights(const MagneticField< Device > &magnetic_field, const SimdVector &v, const Simd< double > &psi, SimdVector2D &xff, SimdGridWeights< Order::One, PIT > &grid_wts) const
Definition: plane.tpp:467
Definition: simd.hpp:149
KOKKOS_INLINE_FUNCTION bool node_is_in_region_1_or_2_no_wall(const int inode) const
Definition: plane.tpp:739
double eps_flux_surface
The minimum difference in psi that counts as being on two different flux surfaces.
Definition: plane.hpp:286
Definition: gradient_matrices.hpp:9
Kokkos::View< RZPair *, Kokkos::LayoutRight, Device > gx
Definition: plane.hpp:260
void mirror_copy(T1 &view_dest, const T2 &view_src)
Definition: my_mirror_view.hpp:122
KOKKOS_INLINE_FUNCTION double get_dist_from_node(const int inode, const double r, const double z) const
Definition: plane.tpp:900
UniformRange psi00
Definition: plane.hpp:272
Definition: grid_weights.hpp:73
double maxval_psi_surf2
Definition: plane.hpp:266
KOKKOS_INLINE_FUNCTION void get_triangle_area_and_volume(const MagneticField< Device > &magnetic_field, int i, double &area, double &volume) const
Definition: plane.tpp:698
KOKKOS_INLINE_FUNCTION double node_area_to_volume(const MagneticField< Device > &magnetic_field, double area, int node_index) const
Definition: plane.tpp:683
Definition: grid_weights.hpp:47
double delta_phi
Distance between planes.
Definition: plane.hpp:249
int ntriangle
Number of grid triangles.
Definition: plane.hpp:244
Definition: NamelistReader.hpp:193
Definition: magnetic_field.hpp:12
KOKKOS_INLINE_FUNCTION void search_tr2(const SimdVector2D &xy, Simd< int > &itr, SimdGridVec &pout) const
Definition: plane.tpp:64
KOKKOS_INLINE_FUNCTION double get_r_center_of_mass(int itr) const
Definition: plane.tpp:724
Kokkos::View< Vertex *, Kokkos::LayoutRight, Device > nodes
Definition: plane.hpp:257
GuessTable< Device > guess
Definition: plane.hpp:261
double plane_phi
phi coordinate of this plane
Definition: plane.hpp:247
KOKKOS_INLINE_FUNCTION int get_node_index(int triangle_index, int tri_vertex_index) const
Definition: plane.tpp:667
int nwall
Definition: plane.hpp:280
KOKKOS_INLINE_FUNCTION bool node_is_in_region_3b_no_wall(const MagneticField< Device2 > &magnetic_field, const int inode) const
Definition: plane.tpp:846
KOKKOS_INLINE_FUNCTION void get_wall_index(const Simd< bool > &just_left_the_grid, const SimdVector2D &x, const SimdGridWeights< Order::One, PIT_GLOBAL > &grid_wts, Simd< int > &widx) const
Definition: plane.tpp:579
void write_to_file(const XGC_IO_Stream &stream, const DomainDecomposition< DeviceType > &pol_decomp, bool is_stellarator, const std::string &prefix) const
KOKKOS_INLINE_FUNCTION double get_nearest_midplane(double phi) const
Definition: plane.tpp:1010
Definition: plane.hpp:17
KOKKOS_INLINE_FUNCTION void nearest_node(const SimdGridWeights< Order::One, PIT > &grid_wts, SimdGridWeights< Order::Zero, PIT > &grid_wts0) const
Definition: plane.tpp:512
void draw_ascii_grid(MagneticField< Device > magnetic_field, double rmin, double rmax, double dr, double zmin, double zmax, double dz)
Definition: plane.hpp:216
Plane()
Definition: plane.hpp:28
KOKKOS_INLINE_FUNCTION void t_coeff_mod(const MagneticField< Device > &magnetic_field, const double r, const double z, const double psiin, const int itr, double(&p)[3]) const
Definition: plane.tpp:139
KOKKOS_INLINE_FUNCTION void search_tr_check_guess(const SimdVector2D &x, const Simd< int > &old_itr, Simd< int > &itr, SimdGridVec &p) const
Definition: plane.tpp:278
View< int *, CLayout, Device > psi_map_surf2_to_surf
Definition: plane.hpp:271
Kokkos::View< double *, Kokkos::LayoutRight, Device > psi_surf2
Definition: plane.hpp:269
KOKKOS_INLINE_FUNCTION double get_r(const int inode) const
Definition: plane.tpp:871
Definition: grid_structs.hpp:28
KOKKOS_INLINE_FUNCTION void get_rz_coordinates(const int inode, double &r, double &z) const
Definition: plane.tpp:925
KOKKOS_INLINE_FUNCTION void wedge_modulo_phi(Simd< double > &phi_mod) const
Definition: plane.tpp:550
void setup_1d_flux_surface_grid(const PlaneFiles &plane_files, const MagneticField< DeviceType > &magnetic_field, const View< double *, CLayout, HostType > &node_vol_h)
Definition: guess_table.hpp:8
int nnode
Number of grid nodes.
Definition: plane.hpp:245
KOKKOS_INLINE_FUNCTION int get_characteristic_length(const View< int *, CLayout, DeviceType > &num_t_node, const View< int **, CLayout, DeviceType > &tr_node, const int i, double &dist_triangle, double &dist_psi, double &dist_theta) const
Definition: plane.tpp:1087
KOKKOS_INLINE_FUNCTION void follow_field_to_nearest_midplane(const MagneticField< Device > &magnetic_field, const SimdVector2D &x, const Simd< double > &phi, SimdVector2D &xff) const
Definition: plane.tpp:369
KOKKOS_INLINE_FUNCTION RZPair get_wall_rz(int i_wall) const
Definition: plane.tpp:1256
KOKKOS_INLINE_FUNCTION bool node_is_on_wall(const int inode) const
Definition: plane.tpp:816
KOKKOS_INLINE_FUNCTION bool node_is_in_region_3a_no_wall(const MagneticField< Device2 > &magnetic_field, const int inode) const
Definition: plane.tpp:830
KOKKOS_INLINE_FUNCTION void search_tr2_no_precheck(const double r, const double z, int &itr, double(&p)[3]) const
Definition: plane.tpp:13
KOKKOS_INLINE_FUNCTION bool node_is_in_included_region(const int inode, const bool exclude_private_region) const
Definition: plane.tpp:776
Kokkos::View< double *, Kokkos::LayoutRight, Device > psi_surf
Definition: plane.hpp:267
Kokkos::View< double *, Kokkos::LayoutRight, Device > psi
An array of psi coordinates.
Definition: plane.hpp:252
Plane< Device2 > mirror() const
Definition: plane.hpp:32
int nplanes
Number of planes.
Definition: plane.hpp:246
Kokkos::View< int *, Kokkos::LayoutRight, Device > node_to_wall
Definition: plane.hpp:284
Simd< double > phi
Definition: simd.hpp:152
Definition: matrix.hpp:11
Simd< double > z
Definition: simd.hpp:151
View< int *, CLayout, Device > psi_map_surf_to_surf2
Definition: plane.hpp:270
Definition: xgc_io.hpp:24
KOKKOS_INLINE_FUNCTION void set_grad_matrix_from_psi_theta(bool is_psi_dir, int itr_pos, int itr_neg, double(&p_pos)[3], double(&p_neg)[3], double dl_pos, double dl_neg, int inode, const Matrix< Device > &matrix) const
Definition: plane.tpp:1212
Definition: grid_structs.hpp:7
KOKKOS_INLINE_FUNCTION bool node_is_in_region_2_or_3_no_wall(const int inode) const
Definition: plane.tpp:751
View< T *, CLayout, Device > my_mirror_view(const View< T *, CLayout, Device > &view, Device nd)
Definition: my_mirror_view.hpp:14
Definition: grid_weights.hpp:52
GuessList1D< Device > psi_guess
Definition: plane.hpp:275
KOKKOS_INLINE_FUNCTION void t_coeff(const SimdVector2D &x, const Simd< int > &itr, SimdGridVec &p) const
Definition: plane.tpp:260
double inv_delta_phi
1/delta_phi
Definition: plane.hpp:250
Definition: magnetic_field.F90:1
Kokkos::View< double *, Kokkos::LayoutRight, HostType > psi_surf_h
Definition: plane.hpp:268
int npsi_surf2
Definition: plane.hpp:264
Definition: simd.hpp:139
KOKKOS_INLINE_FUNCTION void get_grid_weights_plane_ff(const MagneticField< Device > &magnetic_field, const SimdVector &v, double phi_plane, SimdGridWeights< Order::One, PhiInterpType::Planes > &grid_wts) const
Definition: plane.tpp:448
KOKKOS_INLINE_FUNCTION bool node_is_inside_psi_range(const MagneticField< Device > &magnetic_field, const int node) const
Definition: plane.tpp:641
Kokkos::View< VertexMap *, Kokkos::LayoutRight, Device > mapping
Definition: plane.hpp:258
Kokkos::View< int *, Kokkos::LayoutRight, Device > basis
0 for Psi-theta, 1 for R-Z ; should be enum (and bool/char?)
Definition: plane.hpp:256
Definition: uniform_range.hpp:8
Definition: grid_files.hpp:21
KOKKOS_INLINE_FUNCTION bool node_is_in_region_1_or_2(const MagneticField< Device > &magnetic_field, const int inode) const
Definition: plane.tpp:790
View< int **, CLayout, Device > adj
The indices of the three adjacent triangles for each triangle.
Definition: plane.hpp:277
KOKKOS_INLINE_FUNCTION bool node_is_in_region_3b(const MagneticField< Device2 > &magnetic_field, const int inode) const
Definition: plane.tpp:804
KOKKOS_INLINE_FUNCTION int uses_rz_basis(const int inode) const
Definition: plane.tpp:859
KOKKOS_INLINE_FUNCTION void get_grid_weights_ff(const MagneticField< Device > &magnetic_field, const SimdVector &v, const Simd< double > &psi_in, SimdVector2D &xff, SimdGridWeights< Order::One, PhiInterpType::Planes > &grid_wts) const
Definition: plane.tpp:420
Kokkos::View< int *, Kokkos::LayoutRight, Device > wall_nodes
Definition: plane.hpp:283
Kokkos::View< int *, Kokkos::LayoutRight, Device > rgn
Definition: plane.hpp:259
double wedge_angle
The size of the wedge (the model is periodic in phi, a angle of e.g. pi means half the tokamak is mod...
Definition: plane.hpp:248
KOKKOS_INLINE_FUNCTION double get_dist2_from_node(const int inode, const double r, const double z) const
Definition: plane.tpp:886
KOKKOS_INLINE_FUNCTION void psi_search(double psi, double &wp, int &ip) const
Definition: plane.tpp:322
Kokkos::View< double *, Kokkos::LayoutRight, Device > bfield
Magnetic field magnitude at nodes.
Definition: plane.hpp:253