4#include "dg/algorithm.h"
27 Fpsi(
const CylindricalFunctorsLvl2& psip,
const CylindricalFunctorsLvl1& ipol,
double x0,
double y0,
bool verbose =
false):
28 psip_(psip), fieldRZYT_(psip, ipol, x0, y0), fieldRZtau_(psip),m_verbose(verbose)
31 double R_O = x0, Z_O = y0;
33 m_ovalue = psip.f()(R_O,Z_O);
36 fieldRZYT_ = dg::geo::flux::FieldRZYT(psip, ipol, R_O, Z_O);
37 X_init = x0, Y_init = y0;
38 while( fabs( psip.dfx()(X_init, Y_init)) <= 1e-10 && fabs( psip.dfy()( X_init, Y_init)) <= 1e-10)
42 void find_initial(
double psi,
double& R_0,
double& Z_0)
44 if( ((m_opoint == 1) && (psi < m_ovalue +1e-10)) ||
45 ((m_opoint == 2) && (psi > m_ovalue -1e-10)))
46 throw std::runtime_error(
"GradPsi integrator cannot integrate beyond or so close to O-point!");
48 std::array<double, 2> begin2d{ {0,0} }, end2d(begin2d), end2d_old(begin2d);
49 if(m_verbose)std::cout <<
"In init function\n";
50 begin2d[0] = end2d[0] = end2d_old[0] = X_init;
51 begin2d[1] = end2d[1] = end2d_old[1] = Y_init;
52 double eps = 1e10, eps_old = 2e10;
53 using Vec = std::array<double,2>;
55 begin2d), fieldRZtau_);
56 while( (eps < eps_old || eps > 1e-7) && eps > 1e-14)
58 eps_old = eps; end2d_old = end2d;
59 N*=2; odeint.integrate_steps( psip_.f()(X_init, Y_init), begin2d,
61 eps = sqrt( (end2d[0]-end2d_old[0])*(end2d[0]-end2d_old[0]) + (end2d[1]-end2d_old[1])*(end2d[1]-end2d_old[1]));
63 X_init = R_0 = end2d_old[0], Y_init = Z_0 = end2d_old[1];
64 if(m_verbose)std::cout <<
"In init function error: psi(R,Z)-psi0: "<<psip_.f()(X_init, Y_init)-psi<<
"\n";
68 double construct_f(
double psi,
double& R_0,
double& Z_0)
70 find_initial( psi, R_0, Z_0);
71 std::array<double,3> begin{ {0,0,0} }, end(begin), end_old(begin);
72 begin[0] = R_0, begin[1] = Z_0;
73 double eps = 1e10, eps_old = 2e10;
75 unsigned nan_counter = 0;
76 using Vec = std::array<double,3>;
79 while( (eps < eps_old || eps > 1e-7)&& eps > 1e-14)
81 eps_old = eps, end_old = end; N*=2;
82 odeint.integrate_steps( 0., begin, 2*M_PI, end, N);
83 eps = sqrt( (end[0]-begin[0])*(end[0]-begin[0]) +
84 (end[1]-begin[1])*(end[1]-begin[1]));
85 if(m_verbose)std::cout <<
"\t error "<<eps<<
" with "<<N<<
" steps\t";
86 if( std::isnan( eps) && nan_counter < 4) eps = 1e10, end = end_old, nan_counter++;
88 if(m_verbose)std::cout <<
"\t error "<<eps<<
" with "<<N<<
" steps\t";
89 if(m_verbose)std::cout <<end_old[2] <<
" "<<end[2] <<
"\n";
90 double f_psi = 2.*
M_PI/end[2];
94 double operator()(
double psi)
97 if( ((m_opoint == 1) && (psi < m_ovalue +1e-10)) ||
98 ((m_opoint == 2) && (psi > m_ovalue -1e-10)))
101 return construct_f( psi, R_0, Z_0);
103 double f_prime(
double psi)
106 double deltaPsi = fabs(psi)/100.;
108 fofpsi[1] = operator()(psi-deltaPsi);
109 fofpsi[2] = operator()(psi+deltaPsi);
110 double fprime = (-0.5*fofpsi[1]+0.5*fofpsi[2])/deltaPsi, fprime_old;
111 double eps = 1e10, eps_old=2e10;
112 while( eps < eps_old)
117 fofpsi[0] = fofpsi[1], fofpsi[3] = fofpsi[2];
118 fofpsi[1] = operator()(psi-deltaPsi);
119 fofpsi[2] = operator()(psi+deltaPsi);
121 fprime = (+ 1./12.*fofpsi[0]
126 eps = fabs((fprime - fprime_old)/fprime);
135 double X_init, Y_init;
136 CylindricalFunctorsLvl1 psip_;
137 dg::geo::flux::FieldRZYT fieldRZYT_;
138 dg::geo::FieldRZtau fieldRZtau_;
188 psi_(psi), ipol_(ipol), mode_(mode), m_verbose( verbose)
190 psi0_ = psi_0, psi1_ = psi_1;
191 assert( psi_1 != psi_0);
194 flux::detail::Fpsi fpsi(psi, ipol, x0, y0, m_verbose);
195 f0_ = fabs( fpsi.construct_f( psi_0, x0_, y0_));
199 ribeiro::detail::Fpsi fpsi(psi, x0, y0, mode, m_verbose);
200 f0_ = fabs( fpsi.construct_f( psi_0, x0_, y0_));
202 if( psi_1 < psi_0) f0_*=-1;
203 lx_ = f0_*(psi_1-psi_0);
204 x0_=x0, y0_=y0, psi0_=psi_0, psi1_=psi_1;
205 if(m_verbose)std::cout <<
"lx = "<<lx_<<
"\n";
212 virtual double do_width() const override final{
return lx_;}
213 virtual double do_height() const override final{
return 2.*
M_PI;}
214 virtual void do_generate(
215 const thrust::host_vector<double>& zeta1d,
216 const thrust::host_vector<double>& eta1d,
217 thrust::host_vector<double>& x,
218 thrust::host_vector<double>&
y,
219 thrust::host_vector<double>& zetaX,
220 thrust::host_vector<double>& zetaY,
221 thrust::host_vector<double>& etaX,
222 thrust::host_vector<double>& etaY)
const override final
225 thrust::host_vector<double> psi_x(zeta1d);
226 for(
unsigned i=0; i<psi_x.size(); i++)
227 psi_x[i] = zeta1d[i]/f0_ +psi0_;
229 if(m_verbose)std::cout <<
"In grid function:"<<std::endl;
230 flux::detail::Fpsi fpsi(psi_, ipol_, x0_, y0_, m_verbose);
231 dg::geo::flux::FieldRZYRYZY fieldRZYRYZY(psi_, ipol_);
232 ribeiro::detail::Fpsi fpsiRibeiro(psi_, x0_, y0_, mode_, m_verbose);
233 dg::geo::equalarc::FieldRZYRYZY fieldRZYRYZYequalarc(psi_);
234 thrust::host_vector<double> fx_;
235 fx_.resize( zeta1d.size());
236 thrust::host_vector<double> f_p(fx_);
237 unsigned Nx = zeta1d.size(), Ny = eta1d.size();
238 for(
unsigned i=0; i<zeta1d.size(); i++)
240 thrust::host_vector<double> ry, zy;
241 thrust::host_vector<double> yr, yz, xr, xz;
243 if(mode_==0)dg::geo::detail::compute_rzy( fpsi, fieldRZYRYZY, psi_x[i], eta1d, ry, zy, yr, yz, xr, xz, R0, Z0, fx_[i], f_p[i], m_verbose);
244 if(mode_==1)dg::geo::detail::compute_rzy( fpsiRibeiro, fieldRZYRYZYequalarc, psi_x[i], eta1d, ry, zy, yr, yz, xr, xz, R0, Z0, fx_[i], f_p[i], m_verbose);
245 for(
unsigned j=0; j<Ny; j++)
247 x[j*Nx+i] = ry[j],
y[j*Nx+i] = zy[j];
248 etaX[j*Nx+i] = yr[j], etaY[j*Nx+i] = yz[j];
249 zetaX[j*Nx+i] = xr[j]/fx_[i]*f0_, zetaY[j*Nx+i] = xz[j]/fx_[i]*f0_;
253 CylindricalFunctorsLvl2 psi_;
254 CylindricalFunctorsLvl1 ipol_;
255 double f0_, lx_, x0_, y0_, psi0_, psi1_;
293 psip_(psi), mode_(mode), m_verbose(verbose)
295 psi0_ = psi_0, psi1_ = psi_1;
296 assert( psi_1 != psi_0);
297 ribeiro::detail::Fpsi fpsi(psi, x0, y0, mode, m_verbose);
298 f0_ = fabs( fpsi.construct_f( psi_0, x0_, y0_));
299 if( psi_1 < psi_0) f0_*=-1;
300 lx_ = f0_*(psi_1-psi_0);
301 x0_=x0, y0_=y0, psi0_=psi_0, psi1_=psi_1;
302 if(m_verbose)std::cout <<
"lx = "<<lx_<<
"\n";
308 virtual double do_width()
const{
return lx_;}
309 virtual double do_height()
const{
return 2.*
M_PI;}
310 virtual void do_generate(
311 const thrust::host_vector<double>& zeta1d,
312 const thrust::host_vector<double>& eta1d,
313 thrust::host_vector<double>& x,
314 thrust::host_vector<double>&
y,
315 thrust::host_vector<double>& zetaX,
316 thrust::host_vector<double>& zetaY,
317 thrust::host_vector<double>& etaX,
318 thrust::host_vector<double>& etaY)
const
321 thrust::host_vector<double> psi_x(zeta1d);
322 for(
unsigned i=0; i<psi_x.size(); i++)
323 psi_x[i] = zeta1d[i]/f0_ +psi0_;
325 ribeiro::detail::Fpsi fpsi(psip_, x0_, y0_, mode_, m_verbose);
326 dg::geo::ribeiro::FieldRZYRYZY fieldRZYRYZYribeiro(psip_);
327 dg::geo::equalarc::FieldRZYRYZY fieldRZYRYZYequalarc(psip_);
328 thrust::host_vector<double> fx_;
329 fx_.resize( zeta1d.size());
330 thrust::host_vector<double> f_p(fx_);
331 unsigned Nx = zeta1d.size(), Ny = eta1d.size();
332 for(
unsigned i=0; i<zeta1d.size(); i++)
334 thrust::host_vector<double> ry, zy;
335 thrust::host_vector<double> yr, yz, xr, xz;
337 if(mode_==0)dg::geo::detail::compute_rzy( fpsi, fieldRZYRYZYribeiro, psi_x[i], eta1d, ry, zy, yr, yz, xr, xz, R0, Z0, fx_[i], f_p[i], m_verbose);
338 if(mode_==1)dg::geo::detail::compute_rzy( fpsi, fieldRZYRYZYequalarc, psi_x[i], eta1d, ry, zy, yr, yz, xr, xz, R0, Z0, fx_[i], f_p[i], m_verbose);
339 for(
unsigned j=0; j<Ny; j++)
341 x[j*Nx+i] = ry[j],
y[j*Nx+i] = zy[j];
342 etaX[j*Nx+i] = yr[j], etaY[j*Nx+i] = yz[j];
343 zetaX[j*Nx+i] = xr[j]/fx_[i]*f0_, zetaY[j*Nx+i] = xz[j]/fx_[i]*f0_;
347 CylindricalFunctorsLvl2 psip_;
348 double f0_, lx_, x0_, y0_, psi0_, psi1_;
int findOpoint(const CylindricalFunctorsLvl2 &psi, double &RC, double &ZC)
This function finds O-points of psi.
Definition fluxfunctions.h:336
This struct bundles a function and its first derivatives.
Definition fluxfunctions.h:186
This struct bundles a function and its first and second derivatives.
Definition fluxfunctions.h:223
A symmetry flux generator.
Definition flux.h:173
virtual FluxGenerator * clone() const override final
Abstract clone method that returns a copy on the heap.
Definition flux.h:208
FluxGenerator(const CylindricalFunctorsLvl2 &psi, const CylindricalFunctorsLvl1 &ipol, double psi_0, double psi_1, double x0, double y0, int mode=0, bool verbose=false)
Construct a symmetry flux grid generator.
Definition flux.h:187
Same as the Ribeiro class but uses as a flux label directly.
Definition flux.h:280
virtual RibeiroFluxGenerator * clone() const
Abstract clone method that returns a copy on the heap.
Definition flux.h:304
RibeiroFluxGenerator(const CylindricalFunctorsLvl2 &psi, double psi_0, double psi_1, double x0, double y0, int mode=0, bool verbose=false)
Construct a flux aligned grid generator.
Definition flux.h:292
The abstract generator base class.
Definition generator.h:20