16 template<
class Device>
20 template<
class Device2>
friend class Plane;
31 template<
class Device2>
81 #ifdef NO_FORTRAN_MODULES
82 m.gradient_matrices_h = gradient_matrices_h;
96 KOKKOS_INLINE_FUNCTION
void search_tr2_no_precheck(
const double r,
const double z,
int& itr,
double (&p)[3])
const;
102 KOKKOS_INLINE_FUNCTION
void psi_search(
double psi,
double &wp,
int &ip)
const;
112 template<PhiInterpType PIT>
115 template<PhiInterpType PIT>
118 template<PhiInterpType PIT>
121 template<PhiInterpType PIT>
124 template<PhiInterpType PIT>
127 template<PhiInterpType PIT>
130 template<PhiInterpType PIT>
143 KOKKOS_INLINE_FUNCTION
int get_node_index(
int triangle_index,
int tri_vertex_index)
const;
161 template<
class Device2>
166 template<
class Device2>
169 template<
class Device2>
172 KOKKOS_INLINE_FUNCTION
int uses_rz_basis(
const int inode)
const;
174 KOKKOS_INLINE_FUNCTION
double get_r(
const int inode)
const;
176 KOKKOS_INLINE_FUNCTION
double get_dist2_from_node(
const int inode,
const double r,
const double z)
const;
178 KOKKOS_INLINE_FUNCTION
double get_dist_from_node(
const int inode,
const double r,
const double z)
const;
180 KOKKOS_INLINE_FUNCTION
void get_rz_coordinates(
const int inode,
double& r,
double& z)
const;
184 KOKKOS_INLINE_FUNCTION
void get_rz_coordinates(
const int itr,
const double (&p)[3],
double& r,
double& z)
const;
190 KOKKOS_INLINE_FUNCTION
int get_nearest_node(
const int itr,
const double (&p)[3])
const;
195 const View<int**,CLayout,DeviceType>& tr_node,
const View<double*,CLayout,DeviceType>& tr_area,
196 const View<double***, CLayout, DeviceType>& unit_vecs,
200 const View<int**,CLayout,DeviceType>& tr_node,
const int i,
201 double& dist_triangle,
double& dist_psi,
double& dist_theta)
const;
203 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;
210 printf(
"\n\n******** PLOT OF GRID ******* \n");
211 Kokkos::View<int*,HostType> save_vert(
"save_vert", 1+((rmax-rmin)/dr));
212 for (
double zplot = zmax; zplot>=zmin; zplot-=dz){
216 for (
double rplot = rmin; rplot<=rmax; rplot+=dr){
227 if(itr[0]!=save_num || itr[0]!=save_vert[rsave_ind]){
228 if(itr[0]<10 && itr[0]>=0) printf(
"%d ",itr[0]);
229 else printf(
"%d ",itr[0]);
231 save_vert[rsave_ind] = itr[0];
232 }
else {printf(
" ");}
245 Kokkos::View<double*,Kokkos::LayoutRight,Device>
psi;
246 Kokkos::View<double*,Kokkos::LayoutRight,Device>
bfield;
249 Kokkos::View<int*, Kokkos::LayoutRight,Device>
basis;
250 Kokkos::View<Vertex*,Kokkos::LayoutRight,Device>
nodes;
251 Kokkos::View<VertexMap*,Kokkos::LayoutRight,Device>
mapping;
252 Kokkos::View<int*,Kokkos::LayoutRight,Device>
rgn;
253 Kokkos::View<RZPair*,Kokkos::LayoutRight,Device>
gx;
260 Kokkos::View<double*,Kokkos::LayoutRight,Device>
psi_surf2;
266 View<int**,CLayout,Device>
adj;
277 #ifdef NO_FORTRAN_MODULES
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:258
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
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:275
Definition: gradient_matrices.hpp:9
Kokkos::View< RZPair *, Kokkos::LayoutRight, Device > gx
Definition: plane.hpp:253
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:261
Definition: grid_weights.hpp:73
double maxval_psi_surf2
Definition: plane.hpp:259
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:242
int ntriangle
Number of grid triangles.
Definition: plane.hpp:237
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:250
GuessTable< Device > guess
Definition: plane.hpp:254
double plane_phi
phi coordinate of this plane
Definition: plane.hpp:240
KOKKOS_INLINE_FUNCTION int get_node_index(int triangle_index, int tri_vertex_index) const
Definition: plane.tpp:667
int nwall
Definition: plane.hpp:269
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
KOKKOS_INLINE_FUNCTION double get_nearest_midplane(double phi) const
Definition: plane.tpp:1010
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:209
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:260
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:238
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
An array of psi coordinates.
Definition: plane.hpp:245
Plane< Device2 > mirror() const
Definition: plane.hpp:32
int nplanes
Number of planes.
Definition: plane.hpp:239
Kokkos::View< int *, Kokkos::LayoutRight, Device > node_to_wall
Definition: plane.hpp:273
Simd< double > phi
Definition: simd.hpp:152
void write_to_file(const XGC_IO_Stream &stream) const
Definition: matrix.hpp:11
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: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:264
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:243
Definition: magnetic_field.F90:1
int npsi_surf2
Definition: plane.hpp:257
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:251
Kokkos::View< int *, Kokkos::LayoutRight, Device > basis
0 for Psi-theta, 1 for R-Z ; should be enum (and bool/char?)
Definition: plane.hpp:249
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:266
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:272
Kokkos::View< int *, Kokkos::LayoutRight, Device > rgn
Definition: plane.hpp:252
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:241
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:246