5#include "dg/algorithm.h"
38static void parse_method( std::string method, std::string& i, std::string& p, std::string& f)
41 if( method ==
"dg") i =
"dg", p =
"dg";
42 else if( method ==
"linear") i =
"linear", p =
"dg";
43 else if( method ==
"cubic") i =
"cubic", p =
"dg";
44 else if( method ==
"nearest") i =
"nearest", p =
"dg";
45 else if( method ==
"dg-nearest") i =
"dg", p =
"nearest";
46 else if( method ==
"linear-nearest") i =
"linear", p =
"nearest";
47 else if( method ==
"cubic-nearest") i =
"cubic", p =
"nearest";
48 else if( method ==
"nearest-nearest") i =
"nearest", p =
"nearest";
49 else if( method ==
"dg-linear") i =
"dg", p =
"linear";
50 else if( method ==
"linear-linear") i =
"linear", p =
"linear";
51 else if( method ==
"cubic-linear") i =
"cubic", p =
"linear";
52 else if( method ==
"nearest-linear") i =
"nearest", p =
"linear";
53 else if( method ==
"dg-equi") i =
"dg", p =
"dg", f =
"equi";
54 else if( method ==
"linear-equi") i =
"linear", p =
"dg", f =
"equi";
55 else if( method ==
"cubic-equi") i =
"cubic", p =
"dg", f =
"equi";
56 else if( method ==
"nearest-equi") i =
"nearest", p =
"dg", f =
"equi";
57 else if( method ==
"dg-equi-nearest") i =
"dg", p =
"nearest", f =
"equi";
58 else if( method ==
"linear-equi-nearest") i =
"linear", p =
"nearest", f =
"equi";
59 else if( method ==
"cubic-equi-nearest") i =
"cubic", p =
"nearest", f =
"equi";
60 else if( method ==
"nearest-equi-nearest") i =
"nearest", p =
"nearest", f =
"equi";
61 else if( method ==
"dg-equi-linear") i =
"dg", p =
"linear", f =
"equi";
62 else if( method ==
"linear-equi-linear") i =
"linear", p =
"linear", f =
"equi";
63 else if( method ==
"cubic-equi-linear") i =
"cubic", p =
"linear", f =
"equi";
64 else if( method ==
"nearest-equi-linear") i =
"nearest", p =
"linear", f =
"equi";
69struct DSFieldCylindrical3
72 void operator()(
double t,
const std::array<double,3>&
y,
73 std::array<double,3>& yp)
const {
74 double R =
y[0], Z =
y[1];
75 double vz = m_v.z()(R, Z);
76 yp[0] = m_v.x()(R, Z)/vz;
77 yp[1] = m_v.y()(R, Z)/vz;
84struct DSFieldCylindrical4
87 void operator()(
double t,
const std::array<double,3>&
y,
88 std::array<double,3>& yp)
const {
89 double R =
y[0], Z =
y[1];
90 double vx = m_v.x()(R,Z);
91 double vy = m_v.y()(R,Z);
92 double vz = m_v.z()(R,Z);
93 double divvvz = m_v.divvvz()(R,Z);
124 void operator()(
double t,
const std::array<double,3>&
y, std::array<double,3>& yp)
const
132 thrust::host_vector<double> dzetadphi_, detadphi_, dvdphi_;
137template<
class real_type>
141 std::array<thrust::host_vector<real_type>,3>& yp,
142 const thrust::host_vector<double>& vol0,
143 thrust::host_vector<real_type>& yp2b,
144 thrust::host_vector<bool>& in_boxp,
145 real_type deltaPhi, real_type eps)
149 std::array<thrust::host_vector<real_type>,3>
y{
156 dg::geo::detail::DSField field;
158 field = dg::geo::detail::DSField( vec, grid_field);
161 dg::geo::detail::DSFieldCylindrical4 cyl_field(vec);
162 const unsigned size = grid_evaluate.
size();
164 "Dormand-Prince-7-4-5", std::array<real_type,3>{0,0,0});
173 for(
unsigned i=0; i<size; i++)
175 std::array<real_type,3> coords{
y[0][i],
y[1][i],
y[2][i]}, coordsP;
177 real_type phi1 = deltaPhi;
178 odeint.set_dt( deltaPhi/2.);
179 odeint.integrate( 0, coords, phi1, coordsP);
180 yp[0][i] = coordsP[0], yp[1][i] = coordsP[1], yp[2][i] = coordsP[2];
182 yp2b.assign( grid_evaluate.
size(), deltaPhi);
183 in_boxp.resize( yp2b.size());
185 for(
unsigned i=0; i<size; i++)
187 std::array<real_type,3> coords{
y[0][i],
y[1][i],
y[2][i]}, coordsP;
188 in_boxp[i] = grid_field.
contains( std::array{yp[0][i], yp[1][i]}) ?
true :
false;
189 if(
false == in_boxp[i])
192 real_type phi1 = deltaPhi;
193 odeint.integrate_in_domain( 0., coords, phi1, coordsP, 0., (
const
269template<
class ProductGeometry,
class IMatrix,
class container >
278 template <
class Limiter>
280 const ProductGeometry&
grid,
285 unsigned mx=12,
unsigned my=12,
287 std::string interpolation_method =
"linear-nearest",
298 template <
class Limiter>
300 const ProductGeometry&
grid,
305 unsigned mx=12,
unsigned my=12,
307 std::string interpolation_method =
"linear-nearest",
315 template<
class ...Params>
394 const container&
hbm()
const {
399 const container&
hbp()
const {
434 const container&
bbm()
const {
439 const container&
bbo()
const {
444 const container&
bbp()
const {
448 const ProductGeometry&
grid()
const{
return *m_g;}
504 template<
class BinaryOp,
class UnaryOp>
505 container
evaluate( BinaryOp binary, UnaryOp unary,
506 unsigned p0,
unsigned rounds)
const;
509 std::string
method()
const{
return m_interpolation_method;}
512 void ePlus(
enum whichMatrix which,
const container& in, container& out);
513 void eMinus(
enum whichMatrix which,
const container& in, container& out);
514 void zero(
enum whichMatrix which,
const container& in, container& out);
515 IMatrix m_plus, m_zero, m_minus, m_plusT, m_minusT;
516 container m_hbm, m_hbp;
517 container m_G, m_Gm, m_Gp;
518 container m_bphi, m_bphiM, m_bphiP;
519 container m_bbm, m_bbp, m_bbo;
521 container m_left, m_right;
523 container m_ghostM, m_ghostP;
524 unsigned m_Nz, m_perp_size;
525 dg::bc m_bcx, m_bcy, m_bcz;
526 std::vector<dg::View<const container>> m_f;
527 std::vector<dg::View< container>> m_temp;
531 std::string m_interpolation_method;
533 bool m_have_adjoint =
false;
534 void updateAdjoint( )
536 m_plusT = m_plus.transpose();
537 m_minusT = m_minus.transpose();
538 m_have_adjoint =
true;
545template<
class Geometry,
class IMatrix,
class container>
546template <
class Limiter>
549 const Geometry& grid,
551 unsigned mx,
unsigned my,
double deltaPhi, std::string interpolation_method,
bool benchmark) :
553 m_interpolation_method(interpolation_method)
556 std::string inter_m, project_m, fine_m;
557 detail::parse_method( interpolation_method, inter_m, project_m, fine_m);
558 if( benchmark) std::cout <<
"# Interpolation method: \""<<inter_m <<
"\" projection method: \""<<project_m<<
"\" fine grid \""<<fine_m<<
"\"\n";
569 if( benchmark) t.
tic();
574 grid_equidist.set( 1,
grid.gx().size(),
grid.gy().size());
576 grid_magnetic->set( grid_transform->n() < 3 ? 4 : 7, grid_magnetic->Nx(), grid_magnetic->Ny());
578 if( project_m !=
"dg" && fine_m ==
"dg")
580 unsigned rx = mx %
grid.nx(), ry = my %
grid.ny();
581 if( 0 != rx || 0 != ry)
583 std::cerr <<
"#Warning: for projection method \"const\" mx and my must be multiples of nx and ny! Rounding up for you ...\n";
584 mx = mx +
grid.nx() - rx;
585 my = my +
grid.ny() - ry;
588 if( fine_m ==
"equi")
589 grid_fine = grid_equidist;
590 grid_fine.multiplyCellNumbers((
double)mx, (
double)my);
594 std::cout <<
"# DS: High order grid gen took: "<<t.
diff()<<
"\n";
598 std::array<thrust::host_vector<double>,3> yp_trafo, ym_trafo, yp, ym;
599 thrust::host_vector<bool> in_boxp, in_boxm;
600 thrust::host_vector<double>
hbp,
hbm;
604 detail::integrate_all_fieldlines2d( vec, *grid_magnetic, *grid_transform,
606 detail::integrate_all_fieldlines2d( vec, *grid_magnetic, *grid_transform,
612 *grid_transform,
dg::NEU,
dg::NEU, grid_transform->n() < 3 ?
"cubic" :
"dg");
615 for(
int i=0; i<2; i++)
624 std::cout <<
"# DS: Computing all points took: "<<t.
diff()<<
"\n";
630 if( project_m ==
"dg")
637 std::array<dg::HVec*,3> xcomp{ &yp[0], &Xf, &ym[0]};
638 std::array<dg::HVec*,3> ycomp{ &yp[1], &Yf, &ym[1]};
639 std::array<IMatrix*,3> result{ &m_plus, &m_zero, &m_minus};
641 for(
unsigned u=0; u<3; u++)
646 *grid_transform,
bcx,
bcy,
"dg");
660 std::cout <<
"# DS: Multiplication PI took: "<<t.
diff()<<
"\n";
663 dg::HVec hbphi( yp_trafo[2]), hbphiP(hbphi), hbphiM(hbphi);
668 for(
unsigned i=0; i<hbphiP.size(); i++)
670 hbphiP[i] = vec.
z()(yp_trafo[0][i], yp_trafo[1][i]);
671 hbphiM[i] = vec.
z()(ym_trafo[0][i], ym_trafo[1][i]);
678 for(
unsigned i=0; i<yp_trafo[0].size(); i++)
681 yp_trafo[1][i], *grid_magnetic);
683 ym_trafo[1][i], *grid_magnetic);
708 thrust::host_vector<double>
bbm( in_boxp.size(),0.),
bbo(
bbm),
bbp(
bbm);
709 for(
unsigned i=0; i<in_boxp.size(); i++)
711 if( !in_boxp[i] && !in_boxm[i])
713 else if( !in_boxp[i] && in_boxm[i])
715 else if( in_boxp[i] && !in_boxm[i])
726 m_perp_size = grid_transform->size();
729 m_ghostM = m_ghostP = m_right = m_left;
733template<
class G,
class I,
class container>
735 const G& grid,
const container& in)
740 assert( m_g->Nz() % grid.Nz() == 0);
741 unsigned Nz_coarse = grid.Nz(), Nz = m_g->Nz();
742 unsigned cphi = Nz / Nz_coarse;
747 std::vector<dg::View< container>> out_split =
dg::split( out, *m_g);
748 std::vector<dg::View< const container>> in_split =
dg::split( in, grid);
749 for (
int i=0; i<(int)Nz_coarse; i++)
757 for (
int i=0; i<(int)Nz_coarse; i++)
759 for(
int j=1; j<(int)cphi; j++)
764 dg::blas2::symv( m_plus, m_temp[(i*cphi+cphi+1-j)%Nz], m_temp[i*cphi+cphi-j]);
768 for(
int i=0; i<(int)Nz_coarse; i++)
769 for(
int j=1; j<(int)cphi; j++)
771 double alpha = (double)(cphi-j)/(double)cphi;
772 double beta = (double)j/(
double)cphi;
773 dg::blas1::axpby( alpha, out_split[i*cphi+j], beta, m_temp[i*cphi+j], out_split[i*cphi+j]);
777template<
class G,
class I,
class container>
780 assert( m_g->Nz() % grid.Nz() == 0);
781 unsigned Nz_coarse = grid.Nz(), Nz = m_g->Nz();
782 unsigned cphi = Nz / Nz_coarse;
785 container helperP( in), helperM(in), tempP(in), tempM(in);
788 for(
int j=1; j<(int)cphi; j++)
802template<
class G,
class I,
class container>
812template<
class G,
class I,
class container>
813void Fieldaligned<G, I, container>::zero(
enum whichMatrix which,
814 const container& f, container& f0)
819 for(
unsigned i0=0; i0<m_Nz; i0++)
827 if( ! m_have_adjoint) updateAdjoint( );
832 if( ! m_have_adjoint) updateAdjoint( );
837 if ( m_interpolation_method !=
"dg" )
846template<
class G,
class I,
class container>
847void Fieldaligned<G, I, container>::ePlus(
enum whichMatrix which,
848 const container& f, container& fpe)
853 for(
unsigned i0=0; i0<m_Nz; i0++)
855 unsigned ip = (i0==m_Nz-1) ? 0:i0+1;
860 if( ! m_have_adjoint) updateAdjoint( );
878template<
class G,
class I,
class container>
879void Fieldaligned<G, I, container>::eMinus(
enum whichMatrix which,
880 const container& f, container& fme)
885 for(
unsigned i0=0; i0<m_Nz; i0++)
887 unsigned im = (i0==0) ? m_Nz-1:i0-1;
890 if( ! m_have_adjoint) updateAdjoint( );
910template<
class G,
class I,
class container>
911template<
class BinaryOp,
class UnaryOp>
913 UnaryOp unary,
unsigned p0,
unsigned rounds)
const
917 assert( p0 < m_g->Nz());
922 container temp(init2d), tempP(init2d), tempM(init2d);
924 std::vector<container> plus2d(m_Nz, zero2d), minus2d(plus2d), result(plus2d);
925 unsigned turns = rounds;
926 if( turns ==0) turns++;
928 for(
unsigned r=0; r<turns; r++)
929 for(
unsigned i0=0; i0<m_Nz; i0++)
933 unsigned rep = r*m_Nz + i0;
934 for(
unsigned k=0; k<rep; k++)
951 for(
unsigned i0=0; i0<m_Nz; i0++)
953 int idx = (int)i0 - (
int)p0;
955 result[i0] = plus2d[idx];
957 result[i0] = minus2d[abs(idx)];
958 thrust::copy( result[i0].begin(), result[i0].end(), vec3d.begin() + i0*m_perp_size);
963 for(
unsigned i0=0; i0<m_Nz; i0++)
965 unsigned revi0 = (m_Nz - i0)%m_Nz;
970 for(
unsigned i0=0; i0<m_Nz; i0++)
972 int idx = ((int)i0 -(int)p0 + m_Nz)%m_Nz;
973 thrust::copy( result[idx].begin(), result[idx].end(), vec3d.begin() + i0*m_perp_size);
1013template<
class BinaryOp,
class UnaryOp>
1017 const BinaryOp& binary,
1018 const UnaryOp& unary,
1023 unsigned Nz = grid.
Nz();
1027 std::vector<dg::HVec> plus2d(Nz, tempP), minus2d(plus2d), result(plus2d);
1030 std::array<dg::HVec,3> yy0{
1034 dg::geo::detail::DSFieldCylindrical3 cyl_field(vec);
1035 double deltaPhi = grid.
hz();
1036 double phiM0 = 0., phiP0 = 0.;
1037 unsigned turns = rounds;
1038 if( turns == 0) turns++;
1039 for(
unsigned r=0; r<turns; r++)
1040 for(
unsigned i0=0; i0<Nz; i0++)
1042 unsigned rep = r*Nz + i0;
1044 tempM = tempP = init2d;
1048 "Dormand-Prince-7-4-5", std::array<double,3>{0,0,0});
1052 for(
unsigned i=0; i<g2d->size(); i++)
1055 double phiM1 = phiM0 + deltaPhi;
1056 std::array<double,3>
1057 coords0{yy0[0][i],yy0[1][i],yy0[2][i]}, coords1;
1058 odeint.integrate_in_domain( phiM0, coords0, phiM1, coords1,
1059 deltaPhi, *g2d, eps);
1060 yy1[0][i] = coords1[0], yy1[1][i] = coords1[1], yy1[2][i] =
1062 tempM[i] = binary( yy1[0][i], yy1[1][i]);
1065 double phiP1 = phiP0 - deltaPhi;
1066 coords0 = std::array<double,3>{xx0[0][i],xx0[1][i],xx0[2][i]};
1067 odeint.integrate_in_domain( phiP0, coords0, phiP1, coords1,
1068 -deltaPhi, *g2d, eps);
1069 xx1[0][i] = coords1[0], xx1[1][i] = coords1[1], xx1[2][i] =
1071 tempP[i] = binary( xx1[0][i], xx1[1][i]);
1073 std::swap( yy0, yy1);
1074 std::swap( xx0, xx1);
1086 for(
unsigned i0=0; i0<Nz; i0++)
1088 int idx = (int)i0 - (
int)p0;
1090 result[i0] = plus2d[idx];
1092 result[i0] = minus2d[abs(idx)];
1093 thrust::copy( result[i0].begin(), result[i0].end(), vec3d.begin() +
1099 for(
unsigned i0=0; i0<Nz; i0++)
1101 unsigned revi0 = (Nz - i0)%Nz;
1106 for(
unsigned i0=0; i0<Nz; i0++)
1108 int idx = ((int)i0 -(int)p0 + Nz)%Nz;
1109 thrust::copy( result[idx].begin(), result[idx].end(), vec3d.begin()
DG_DEVICE T zero(T x, Ts ...xs)
DG_DEVICE double cooY2d(double x, double y)
DG_DEVICE double cooX2d(double x, double y)
void copy(const ContainerTypeIn &source, ContainerTypeOut &target)
void axpby(value_type alpha, const ContainerType1 &x, value_type1 beta, ContainerType &y)
void pointwiseDot(value_type alpha, const ContainerType1 &x1, const ContainerType2 &x2, value_type1 beta, ContainerType &y)
void assign(const from_ContainerType &from, ContainerType &to, Params &&... ps)
void scal(ContainerType &x, value_type alpha)
void pointwiseDivide(value_type alpha, const ContainerType1 &x1, const ContainerType2 &x2, value_type1 beta, ContainerType &y)
void symv(MatrixType &&M, const ContainerType1 &x, ContainerType2 &y)
std::string bc2str(bc bcx)
auto weights(const Topology &g)
auto evaluate(Functor &&f, const Topology &g)
whichMatrix
Enum for the use in Fieldaligned.
Definition fieldaligned.h:16
ZERO NoLimiter
No Limiter.
Definition fieldaligned.h:34
thrust::host_vector< double > fieldaligned_evaluate(const aProductGeometry3d &grid, const CylindricalVectorLvl0 &vec, const BinaryOp &binary, const UnaryOp &unary, unsigned p0, unsigned rounds, double eps=1e-5)
Evaluate a 2d functor and transform to all planes along the fieldlines
Definition fieldaligned.h:1014
ONE FullLimiter
Full Limiter means there is a limiter everywhere.
Definition fieldaligned.h:30
@ einsPlusT
transposed plus interpolation in previous plane
Definition fieldaligned.h:18
@ zeroPlus
plus interpolation in the current plane
Definition fieldaligned.h:21
@ einsPlus
plus interpolation in next plane
Definition fieldaligned.h:17
@ zeroForw
from dg to transformed coordinates
Definition fieldaligned.h:25
@ zeroMinusT
transposed minus interpolation in the current plane
Definition fieldaligned.h:24
@ einsMinus
minus interpolation in previous plane
Definition fieldaligned.h:19
@ zeroPlusT
transposed plus interpolation in the current plane
Definition fieldaligned.h:23
@ einsMinusT
transposed minus interpolation in next plane
Definition fieldaligned.h:20
@ zeroMinus
minus interpolation in the current plane
Definition fieldaligned.h:22
Topology::host_vector forward_transform(const typename Topology::host_vector &in, const Topology &g)
real_type interpolate(dg::space sp, const host_vector &v, real_type x, const RealGrid1d< real_type > &g, dg::bc bcx=dg::NEU)
dg::MIHMatrix_t< typename MPITopology::value_type > projection(const MPITopology &g_new, const MPITopology &g_old, std::string method="dg")
dg::SparseMatrix< int, real_type, thrust::host_vector > interpolation(const RecursiveHostVector &x, const aRealTopology< real_type, Nd > &g, std::array< dg::bc, Nd > bcx, std::string method="dg")
CylindricalVectorLvl1 createBHat(const TokamakMagneticField &mag)
Contravariant components of the magnetic unit vector field and its Divergence and derivative in cylin...
Definition magnetic_field.h:934
Geometry::host_vector pullback(const Functor &f, const Geometry &g)
void pushForwardPerp(const Functor1 &vR, const Functor2 &vZ, container &vx, container &vy, const Geometry &g)
void assign3dfrom2d(const host_vector &in2d, Container &out, const Topology &grid)
dg::IHMatrix_t< real_type > inv_backproject(const aRealTopology< real_type, Nd > &g)
dg::IHMatrix_t< real_type > backproject(const aRealTopology< real_type, Nd > &g)
void split(SharedContainer &in, std::vector< View< SharedContainer > > &out, const aRealTopology3d< real_type > &grid)
ContainerType volume(const SparseTensor< ContainerType > &t)
thrust::host_vector< double > HVec
aRealGeometry2d< real_type > * perp_grid() const
std::enable_if_t<(Md==1), bool > contains(real_type x) const
Definition fluxfunctions.h:416
This struct bundles a vector field and its divergence.
Definition fluxfunctions.h:444
const CylindricalFunctor & y() const
y-component of the vector
Definition fluxfunctions.h:472
const CylindricalFunctor & x() const
x-component of the vector
Definition fluxfunctions.h:470
const CylindricalFunctor & divvvz() const
Definition fluxfunctions.h:478
const CylindricalFunctor & z() const
z-component of the vector
Definition fluxfunctions.h:474
Create and manage interpolation matrices from fieldline integration.
Definition fieldaligned.h:271
dg::bc bcx() const
Definition fieldaligned.h:322
const container & hbp() const
Distance between the planes .
Definition fieldaligned.h:399
const container & bphi() const
bphi
Definition fieldaligned.h:419
container interpolate_from_coarse_grid(const ProductGeometry &grid_coarse, const container &coarse)
Interpolate along fieldlines from a coarse to a fine grid in phi.
Fieldaligned(const dg::geo::TokamakMagneticField &vec, const ProductGeometry &grid, dg::bc bcx=dg::NEU, dg::bc bcy=dg::NEU, Limiter limit=FullLimiter(), double eps=1e-5, unsigned mx=12, unsigned my=12, double deltaPhi=-1, std::string interpolation_method="linear-nearest", bool benchmark=true)
Construct from a magnetic field and a grid.
Definition fieldaligned.h:279
void integrate_between_coarse_grid(const ProductGeometry &grid_coarse, const container &coarse, container &out)
Integrate a 2d function on the fine grid.
const container & bbp() const
Mask plus, 1 if fieldline intersects wall in plus direction but not in minus direction,...
Definition fieldaligned.h:444
container evaluate(BinaryOp binary, UnaryOp unary, unsigned p0, unsigned rounds) const
Evaluate a 2d functor and transform to all planes along the fieldline
const container & sqrtG() const
Volume form (including weights) .
Definition fieldaligned.h:404
void operator()(enum whichMatrix which, const container &in, container &out)
Apply the interpolation to three-dimensional vectors.
const container & sqrtGm() const
Volume form on minus plane (including weights) .
Definition fieldaligned.h:409
void set_boundaries(dg::bc bcz, double left, double right)
Set boundary conditions in the limiter region.
Definition fieldaligned.h:339
std::string method() const
Return the interpolation_method string given in the constructor.
Definition fieldaligned.h:509
const container & hbm() const
Distance between the planes and the boundary .
Definition fieldaligned.h:394
void set_boundaries(dg::bc bcz, const container &global, double scal_left, double scal_right)
Set boundary conditions in the limiter region.
Definition fieldaligned.h:373
const container & bphiM() const
bphi on minus plane
Definition fieldaligned.h:424
dg::bc bcy() const
Definition fieldaligned.h:325
double deltaPhi() const
Definition fieldaligned.h:391
Fieldaligned()
do not allocate memory; no member call except construct is valid
Definition fieldaligned.h:274
void construct(Params &&...ps)
Perfect forward parameters to one of the constructors.
Definition fieldaligned.h:316
const container & bbo() const
Mask both, 1 if fieldline intersects wall in plus direction and in minus direction,...
Definition fieldaligned.h:439
const container & bbm() const
Mask minus, 1 if fieldline intersects wall in minus direction but not in plus direction,...
Definition fieldaligned.h:434
const container & sqrtGp() const
Volume form on plus plane (including weights) .
Definition fieldaligned.h:414
Fieldaligned(const dg::geo::CylindricalVectorLvl1 &vec, const ProductGeometry &grid, dg::bc bcx=dg::NEU, dg::bc bcy=dg::NEU, Limiter limit=FullLimiter(), double eps=1e-5, unsigned mx=12, unsigned my=12, double deltaPhi=-1, std::string interpolation_method="linear-nearest", bool benchmark=true)
Construct from a vector field and a grid.
const container & bphiP() const
bphi on plus plane
Definition fieldaligned.h:429
const ProductGeometry & grid() const
Grid used for construction.
Definition fieldaligned.h:448
void set_boundaries(dg::bc bcz, const container &left, const container &right)
Set boundary conditions in the limiter region.
Definition fieldaligned.h:356
A tokamak field as given by R0, Psi and Ipol plus Meta-data like shape and equilibrium.
Definition magnetic_field.h:165