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, 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;
39  m.delta_phi = delta_phi;
41 
42  m.psi = my_mirror_view(psi, Device2());
43  mirror_copy(m.psi, psi);
44  m.bfield = my_mirror_view(bfield, Device2());
46  m.basis = my_mirror_view(basis, Device2());
48  m.nodes = my_mirror_view(nodes, Device2());
50  m.mapping = my_mirror_view(mapping, Device2());
52 
53  m.guess = guess.template mirror<Device2>();
54 
58  m.psi_surf2 = my_mirror_view(psi_surf2, Device2());
60 
61  m.psi00 = psi00;
62  m.psi_guess = psi_guess.template mirror<Device2>();
63 
64  m.rgn = my_mirror_view(rgn, Device2());
65  mirror_copy(m.rgn, rgn);
66  m.gx = my_mirror_view(gx, Device2());
67  mirror_copy(m.gx, gx);
68  // This isn't used on GPU right now
69  //m.adj = my_mirror_view(adj, Device2());
70  //mirror_copy(m.adj, adj);
71 
72  m.nwall = nwall;
73  m.wall_nodes = my_mirror_view(wall_nodes, Device2());
77 
79 
80 #ifdef NO_FORTRAN_MODULES
81  m.gradient_matrices_h = gradient_matrices_h;
82 #endif
83 
84  return m;
85  }
86 
87  void setup_1d_flux_surface_grid(const PlaneFiles& plane_files, const MagneticField<DeviceType>& magnetic_field, const View<double*,CLayout,HostType>& node_vol_h);
88 
89  KOKKOS_INLINE_FUNCTION void t_coeff(const SimdVector2D &x, const Simd<int>& itr, SimdGridVec &p) const;
90 
91  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;
92 
93  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;
94 
95  KOKKOS_INLINE_FUNCTION void search_tr2_no_precheck(const double r, const double z, int& itr, double (&p)[3]) const;
96 
97  KOKKOS_INLINE_FUNCTION void search_tr2( const SimdVector2D &xy, Simd<int>& itr, SimdGridVec &pout ) const;
98 
99  KOKKOS_INLINE_FUNCTION void search_tr_check_guess(const SimdVector2D &x, const Simd<int>& old_itr,Simd<int>& itr,SimdGridVec &p ) const;
100 
101  KOKKOS_INLINE_FUNCTION void psi_search(double psi,double &wp,int &ip) const;
102 
103  KOKKOS_INLINE_FUNCTION void follow_field_to_nearest_midplane(const MagneticField<Device> &magnetic_field, const SimdVector2D &x, const Simd<double>& phi, SimdVector2D &xff) const;
104 
105  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;
106 
107  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;
108 
109  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;
110 
111  template<PhiInterpType PIT>
112  KOKKOS_INLINE_FUNCTION void nearest_node(const SimdGridWeights<Order::One, PIT>& grid_wts, SimdGridWeights<Order::Zero, PIT>& grid_wts0) const;
113 
114  template<PhiInterpType PIT>
115  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;
116 
117  template<PhiInterpType PIT>
118  KOKKOS_INLINE_FUNCTION void get_grid_weights(const MagneticField<Device> &magnetic_field, const SimdVector &v, SimdVector2D &xff, SimdGridWeights<Order::One, PIT>& grid_wts) const;
119 
120  template<PhiInterpType PIT>
121  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;
122 
123  template<PhiInterpType PIT>
124  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;
125 
126  template<PhiInterpType PIT>
127  KOKKOS_INLINE_FUNCTION void get_grid_weights(const MagneticField<Device> &magnetic_field, const SimdVector &v, SimdGridWeights<Order::Zero, PIT>& grid_wts) const;
128 
129  template<PhiInterpType PIT>
130  KOKKOS_INLINE_FUNCTION void get_grid_weights(const MagneticField<Device> &magnetic_field, const SimdVector &v, SimdGridWeights<Order::One, PIT>& grid_wts) const;
131 
132  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;
133 
134  KOKKOS_INLINE_FUNCTION void wedge_modulo_phi(Simd<double>& phi_mod) const;
135 
136  KOKKOS_INLINE_FUNCTION double wedge_modulo_phi(double phi) const;
137 
138  KOKKOS_INLINE_FUNCTION bool node_is_inside_psi_range(const MagneticField<Device> &magnetic_field, const int node) const;
139 
140  KOKKOS_INLINE_FUNCTION int get_plane_index(double phi) const;
141 
142  KOKKOS_INLINE_FUNCTION int get_node_index(int triangle_index, int tri_vertex_index) const;
143 
144  KOKKOS_INLINE_FUNCTION double node_area_to_volume(const MagneticField<Device> &magnetic_field, double area, int node_index) const;
145 
146  KOKKOS_INLINE_FUNCTION void get_triangle_area_and_volume(const MagneticField<Device> &magnetic_field, int i, double& area, double& volume) const;
147 
148  KOKKOS_INLINE_FUNCTION double get_r_center_of_mass(int itr) const;
149 
150  KOKKOS_INLINE_FUNCTION bool node_is_in_region_1_or_2_no_wall(const int inode) const;
151 
152  KOKKOS_INLINE_FUNCTION bool node_is_in_private_region_no_wall(const int inode) const;
153 
154  KOKKOS_INLINE_FUNCTION bool node_is_in_included_region(const int inode, const bool exclude_private_region) const;
155 
156  KOKKOS_INLINE_FUNCTION bool node_is_in_region_1_or_2(const MagneticField<Device> &magnetic_field, const int inode) const;
157 
158  KOKKOS_INLINE_FUNCTION int uses_rz_basis(const int inode) const;
159 
160  KOKKOS_INLINE_FUNCTION double get_r(const int inode) const;
161 
162  KOKKOS_INLINE_FUNCTION double get_dist2_from_node(const int inode, const double r, const double z) const;
163 
164  KOKKOS_INLINE_FUNCTION double get_dist_from_node(const int inode, const double r, const double z) const;
165 
166  KOKKOS_INLINE_FUNCTION void get_rz_coordinates(const int inode, double& r, double& z) const;
167 
168  KOKKOS_INLINE_FUNCTION void get_rz_coordinates(const Simd<int>& grid_inds, SimdVector2D& x) const;
169 
170  KOKKOS_INLINE_FUNCTION void get_rz_coordinates(const int itr, const double (&p)[3], double& r, double& z) const;
171 
172  KOKKOS_INLINE_FUNCTION void get_rz_coordinates(const Simd<int>& itr, const SimdGridVec& p, SimdVector2D& x) const;
173 
174  KOKKOS_INLINE_FUNCTION int get_nearest_node(const Simd<int>& itr, const SimdGridVec& p, int i_simd) const;
175 
176  KOKKOS_INLINE_FUNCTION int get_nearest_node(const int itr, const double (&p)[3]) const;
177 
178  KOKKOS_INLINE_FUNCTION double get_nearest_midplane(double phi) const;
179 
180  KOKKOS_INLINE_FUNCTION void set_gradient_mat_triangle(const View<int*,CLayout,DeviceType>& num_t_node,
181  const View<int**,CLayout,DeviceType>& tr_node, const View<double*,CLayout,DeviceType>& tr_area,
182  const View<double***, CLayout, DeviceType>& unit_vecs,
183  const int i, const GradientMatrices<Device>& gradient_matrices) const;
184 
185  KOKKOS_INLINE_FUNCTION int get_characteristic_length(const View<int*,CLayout,DeviceType>& num_t_node,
186  const View<int**,CLayout,DeviceType>& tr_node, const int i,
187  double& dist_triangle, double& dist_psi, double& dist_theta) const;
188 
189  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;
190 
191  KOKKOS_INLINE_FUNCTION RZPair get_wall_rz(int i_wall) const;
192 
193  void write_to_file(const XGC_IO_Stream& stream) const;
194 
195  void draw_ascii_grid(MagneticField<Device> magnetic_field, double rmin, double rmax, double dr, double zmin, double zmax, double dz){
196  printf("\n\n******** PLOT OF GRID ******* \n");
197  Kokkos::View<int*,HostType> save_vert("save_vert", 1+((rmax-rmin)/dr));
198  for (double zplot = zmax; zplot>=zmin; zplot-=dz){
199  printf("\n");
200  int save_num = 0;
201  int rsave_ind = -1;
202  for (double rplot = rmin; rplot<=rmax; rplot+=dr){
203  rsave_ind++;
204  SimdVector v;
205  v.r = rplot;
206  v.z = zplot;
207  v.phi = 0.001;
208 
209  // Get itr (triangle index)
210  SimdGridVec p;
211  Simd<int> itr = -1;
212  get_grid_weights(magnetic_field, v, itr, p);
213  if(itr[0]!=save_num || itr[0]!=save_vert[rsave_ind]){
214  if(itr[0]<10 && itr[0]>=0) printf("%d ",itr[0]);
215  else printf("%d ",itr[0]);
216  save_num = itr[0];
217  save_vert[rsave_ind] = itr[0];
218  } else {printf(" ");}
219  }
220  }
221  }
222 
223  int ntriangle;
224  int nnode;
225  int nplanes;
226  double wedge_angle;
227  double delta_phi;
228  double inv_delta_phi;
229 
230  Kokkos::View<double*,Kokkos::LayoutRight,Device> psi;
231  Kokkos::View<double*,Kokkos::LayoutRight,Device> bfield;
232 
233  private:
234  Kokkos::View<int*, Kokkos::LayoutRight,Device> basis;
235  Kokkos::View<Vertex*,Kokkos::LayoutRight,Device> nodes;
236  Kokkos::View<VertexMap*,Kokkos::LayoutRight,Device> mapping;
237  Kokkos::View<int*,Kokkos::LayoutRight,Device> rgn;
238  Kokkos::View<RZPair*,Kokkos::LayoutRight,Device> gx;
240 
241  public:
245  Kokkos::View<double*,Kokkos::LayoutRight,Device> psi_surf2;
247 
248  private:
250 
251  View<int**,CLayout,Device> adj;
252 
253  public:
254  int nwall;
255 
256  //private:
257  Kokkos::View<int*,Kokkos::LayoutRight,Device> wall_nodes;
258  Kokkos::View<int*,Kokkos::LayoutRight,Device> node_to_wall;
259 
261 
262 #ifdef NO_FORTRAN_MODULES
263  GradientMatrices<HostType> gradient_matrices_h;
264 #endif
265 };
266 
267 #include "plane.tpp"
268 #endif
KOKKOS_INLINE_FUNCTION bool node_is_in_private_region_no_wall(const int inode) const
Definition: plane.tpp:750
KOKKOS_INLINE_FUNCTION int get_nearest_node(const Simd< int > &itr, const SimdGridVec &p, int i_simd) const
Definition: plane.tpp:912
double minval_psi_surf2
Definition: plane.hpp:243
KOKKOS_INLINE_FUNCTION int get_plane_index(double phi) const
Definition: plane.tpp:653
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:955
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:466
Definition: simd.hpp:149
KOKKOS_INLINE_FUNCTION bool node_is_in_region_1_or_2_no_wall(const int inode) const
Definition: plane.tpp:738
double eps_flux_surface
The minimum difference in psi that counts as being on two different flux surfaces.
Definition: plane.hpp:260
Definition: gradient_matrices.hpp:9
Kokkos::View< RZPair *, Kokkos::LayoutRight, Device > gx
Definition: plane.hpp:238
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:830
UniformRange psi00
Definition: plane.hpp:246
Definition: grid_weights.hpp:73
double maxval_psi_surf2
Definition: plane.hpp:244
KOKKOS_INLINE_FUNCTION void get_triangle_area_and_volume(const MagneticField< Device > &magnetic_field, int i, double &area, double &volume) const
Definition: plane.tpp:697
KOKKOS_INLINE_FUNCTION double node_area_to_volume(const MagneticField< Device > &magnetic_field, double area, int node_index) const
Definition: plane.tpp:682
Definition: grid_weights.hpp:47
double delta_phi
Distance between planes.
Definition: plane.hpp:227
int ntriangle
Number of grid triangles.
Definition: plane.hpp:223
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:723
Kokkos::View< Vertex *, Kokkos::LayoutRight, Device > nodes
Definition: plane.hpp:235
GuessTable< Device > guess
Definition: plane.hpp:239
KOKKOS_INLINE_FUNCTION int get_node_index(int triangle_index, int tri_vertex_index) const
Definition: plane.tpp:666
int nwall
Definition: plane.hpp:254
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:578
KOKKOS_INLINE_FUNCTION double get_nearest_midplane(double phi) const
Definition: plane.tpp:940
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:511
void draw_ascii_grid(MagneticField< Device > magnetic_field, double rmin, double rmax, double dr, double zmin, double zmax, double dz)
Definition: plane.hpp:195
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
Kokkos::View< double *, Kokkos::LayoutRight, Device > psi_surf2
Definition: plane.hpp:245
KOKKOS_INLINE_FUNCTION double get_r(const int inode) const
Definition: plane.tpp:801
Definition: grid_structs.hpp:28
KOKKOS_INLINE_FUNCTION void get_rz_coordinates(const int inode, double &r, double &z) const
Definition: plane.tpp:855
KOKKOS_INLINE_FUNCTION void wedge_modulo_phi(Simd< double > &phi_mod) const
Definition: plane.tpp:549
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:224
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:1017
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:1186
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:763
Kokkos::View< double *, Kokkos::LayoutRight, Device > psi
An array of psi coordinates.
Definition: plane.hpp:230
Plane< Device2 > mirror() const
Definition: plane.hpp:32
int nplanes
Number of planes.
Definition: plane.hpp:225
Kokkos::View< int *, Kokkos::LayoutRight, Device > node_to_wall
Definition: plane.hpp:258
Simd< double > phi
Definition: simd.hpp:152
void write_to_file(const XGC_IO_Stream &stream) const
Definition: matrix.hpp:13
Simd< double > z
Definition: simd.hpp:151
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:1142
Definition: grid_structs.hpp:7
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:249
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:228
Definition: magnetic_field.F90:1
int npsi_surf2
Definition: plane.hpp:242
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:447
KOKKOS_INLINE_FUNCTION bool node_is_inside_psi_range(const MagneticField< Device > &magnetic_field, const int node) const
Definition: plane.tpp:640
Kokkos::View< VertexMap *, Kokkos::LayoutRight, Device > mapping
Definition: plane.hpp:236
Kokkos::View< int *, Kokkos::LayoutRight, Device > basis
0 for Psi-theta, 1 for R-Z ; should be enum (and bool/char?)
Definition: plane.hpp:234
Definition: uniform_range.hpp:6
Definition: grid_files.hpp:17
KOKKOS_INLINE_FUNCTION bool node_is_in_region_1_or_2(const MagneticField< Device > &magnetic_field, const int inode) const
Definition: plane.tpp:777
View< int **, CLayout, Device > adj
The indices of the three adjacent triangles for each triangle.
Definition: plane.hpp:251
KOKKOS_INLINE_FUNCTION int uses_rz_basis(const int inode) const
Definition: plane.tpp:789
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:257
Kokkos::View< int *, Kokkos::LayoutRight, Device > rgn
Definition: plane.hpp:237
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:226
KOKKOS_INLINE_FUNCTION double get_dist2_from_node(const int inode, const double r, const double z) const
Definition: plane.tpp:816
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:231