Extension: Geometries
#include "dg/geometries/geometries.h"
Loading...
Searching...
No Matches
flux.h
Go to the documentation of this file.
1#pragma once
2
3#include <limits>
4#include "dg/algorithm.h"
5#include "fluxfunctions.h"
6#include "ribeiro.h"
7
8
9namespace dg
10{
11namespace geo
12{
13
15namespace flux
16{
17namespace detail
18{
19
20//This leightweights struct and its methods finds the initial R and Z values and the coresponding f(\psi) as
21//good as it can, i.e. until machine precision is reached
22//Note that f(psi) = 1/q(psi) (The safety factor)
23struct Fpsi
24{
25
26 //firstline = 0 -> conformal, firstline = 1 -> equalarc
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)
29 {
30 //Find O-point
31 double R_O = x0, Z_O = y0;
32 m_opoint = dg::geo::findOpoint( psip, R_O, Z_O);
33 m_ovalue = psip.f()(R_O,Z_O);
34
35 //define angle with respect to O-point
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)
39 X_init += 1.;
40 }
41 //finds the starting points for the integration in y direction
42 void find_initial( double psi, double& R_0, double& Z_0)
43 {
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!");
47 unsigned N = 50;
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>;
54 dg::SinglestepTimeloop<Vec> odeint( dg::RungeKutta<Vec>( "Feagin-17-8-10",
55 begin2d), fieldRZtau_);
56 while( (eps < eps_old || eps > 1e-7) && eps > 1e-14)
57 {
58 eps_old = eps; end2d_old = end2d;
59 N*=2; odeint.integrate_steps( psip_.f()(X_init, Y_init), begin2d,
60 psi, end2d, N);
61 eps = sqrt( (end2d[0]-end2d_old[0])*(end2d[0]-end2d_old[0]) + (end2d[1]-end2d_old[1])*(end2d[1]-end2d_old[1]));
62 }
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";
65 }
66
67 //compute f for a given psi between psi0 and psi1
68 double construct_f( double psi, double& R_0, double& Z_0)
69 {
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;
74 unsigned N = 50;
75 unsigned nan_counter = 0;
76 using Vec = std::array<double,3>;
77 dg::SinglestepTimeloop<Vec> odeint( dg::RungeKutta<Vec>( "Feagin-17-8-10",
78 begin), fieldRZYT_);
79 while( (eps < eps_old || eps > 1e-7)&& eps > 1e-14)
80 {
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++;
87 }
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]; //this actually is 1/q the safety factor
91 return f_psi;
92 }
93
94 double operator()( double psi)
95 {
96 // This is to make the SafetyFactor nothrow
97 if( ((m_opoint == 1) && (psi < m_ovalue +1e-10)) ||
98 ((m_opoint == 2) && (psi > m_ovalue -1e-10)))
99 return std::nan("");
100 double R_0, Z_0;
101 return construct_f( psi, R_0, Z_0);
102 }
103 double f_prime( double psi)
104 {
105 //compute fprime
106 double deltaPsi = fabs(psi)/100.;
107 double fofpsi[4];
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)
113 {
114 deltaPsi /=2.;
115 fprime_old = fprime;
116 eps_old = eps;
117 fofpsi[0] = fofpsi[1], fofpsi[3] = fofpsi[2];
118 fofpsi[1] = operator()(psi-deltaPsi);
119 fofpsi[2] = operator()(psi+deltaPsi);
120 //reuse previously computed fpsi for current fprime
121 fprime = (+ 1./12.*fofpsi[0]
122 - 2./3. *fofpsi[1]
123 + 2./3. *fofpsi[2]
124 - 1./12.*fofpsi[3]
125 )/deltaPsi;
126 eps = fabs((fprime - fprime_old)/fprime);
127 //std::cout << "fprime "<<fprime<<" rel error fprime is "<<eps<<" delta psi "<<deltaPsi<<"\n";
128 }
129 return fprime_old;
130 }
131
132 private:
133 int m_opoint;
134 double m_ovalue;
135 double X_init, Y_init;
136 CylindricalFunctorsLvl1 psip_;
137 dg::geo::flux::FieldRZYT fieldRZYT_;
138 dg::geo::FieldRZtau fieldRZtau_;
139 bool m_verbose;
140
141};
142
143} //namespace detail
144}//namespace flux
146
173{
187 FluxGenerator( const CylindricalFunctorsLvl2& psi, const CylindricalFunctorsLvl1& ipol, double psi_0, double psi_1, double x0, double y0, int mode=0, bool verbose = false):
188 psi_(psi), ipol_(ipol), mode_(mode), m_verbose( verbose)
189 {
190 psi0_ = psi_0, psi1_ = psi_1;
191 assert( psi_1 != psi_0);
192 if( mode==0)
193 {
194 flux::detail::Fpsi fpsi(psi, ipol, x0, y0, m_verbose);
195 f0_ = fabs( fpsi.construct_f( psi_0, x0_, y0_));
196 }
197 else
198 {
199 ribeiro::detail::Fpsi fpsi(psi, x0, y0, mode, m_verbose);
200 f0_ = fabs( fpsi.construct_f( psi_0, x0_, y0_));
201 }
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";
206 }
207
208 virtual FluxGenerator* clone() const override final{return new FluxGenerator(*this);}
209
210 private:
211 // length of zeta-domain (f0*(psi_1-psi_0))
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
223 {
224 //compute psi(x) for a grid on x and call construct_rzy for all psi
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_;
228
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++)
239 {
240 thrust::host_vector<double> ry, zy;
241 thrust::host_vector<double> yr, yz, xr, xz;
242 double R0, Z0;
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++)
246 {
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_;
250 }
251 }
252 }
253 CylindricalFunctorsLvl2 psi_;
254 CylindricalFunctorsLvl1 ipol_;
255 double f0_, lx_, x0_, y0_, psi0_, psi1_;
256 int mode_;
257 bool m_verbose;
258};
259
280{
292 RibeiroFluxGenerator( const CylindricalFunctorsLvl2& psi, double psi_0, double psi_1, double x0, double y0, int mode=0, bool verbose = false):
293 psip_(psi), mode_(mode), m_verbose(verbose)
294 {
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";
303 }
304 virtual RibeiroFluxGenerator* clone() const{return new RibeiroFluxGenerator(*this);}
305
306 private:
307 //length of zeta-domain (f0*(psi_1-psi_0))
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
319 {
320 //compute psi(x) for a grid on x and call construct_rzy for all psi
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_;
324
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++)
333 {
334 thrust::host_vector<double> ry, zy;
335 thrust::host_vector<double> yr, yz, xr, xz;
336 double R0, Z0;
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++)
340 {
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_;
344 }
345 }
346 }
347 CylindricalFunctorsLvl2 psip_;
348 double f0_, lx_, x0_, y0_, psi0_, psi1_;
349 int mode_;
350 bool m_verbose;
351};
352}//namespace geo
353}//namespace dg
#define M_PI
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