38template<
class real_type,
size_t Nd>
89template<
class real_type,
size_t Nd>
102 constexpr static unsigned ndim() {
return Nd;}
124 int dims[Nd], periods[Nd], coords[Nd];
125 MPI_Cart_get( m_comm, Nd, dims, periods, coords);
126 real_type global_x0 = m_g.p(u);
127 real_type global_hx = m_g.h(u);
128 thrust::host_vector<real_type> abs(m_l.shape(u));
130 auto idx = increment( partition( m_g.N(u), dims[u]));
131 for(
unsigned i=0; i<m_l.N(u); i++)
133 for(
unsigned j=0; j<m_l.n(u); j++)
135 unsigned coord = idx[coords[u]] + i;
136 real_type xmiddle = DG_FMA( global_hx, (real_type)(coord), global_x0);
137 real_type h2 = global_hx/2.;
138 real_type absj = 1.+aa[j];
139 abs[i*m_l.n(u)+j] = DG_FMA( h2, absj, xmiddle);
156 throw Error(
Message(
_ping_)<<
"u>Nd not allowed! You typed: "<<u<<
" while Nd is "<<Nd);
157 thrust::host_vector<real_type> v( m_l.shape(u));
159 real_type hu = m_g.h(u);
160 for(
unsigned i=0; i<m_l.N(u); i++)
161 for(
unsigned j=0; j<m_l.n(u); j++)
162 v[i*m_l.n(u) + j] = hu/2.*ww[j];
172 std::array<host_vector,Nd> abs;
173 for(
unsigned u=0; u<Nd; u++)
179 std::array<host_vector,Nd> w;
180 for(
unsigned u=0; u<Nd; u++)
185 std::array<real_type,Nd>
get_p()
const{
189 std::array<real_type,Nd>
get_q()
const{
193 std::array<real_type,Nd>
get_l()
const{
197 std::array<real_type,Nd>
get_h()
const{
201 std::array<unsigned, Nd>
get_N()
const
206 std::array<unsigned, Nd>
get_n()
const
217 std::array<MPI_Comm, Nd>
get_comms()
const {
return m_comms;}
220 real_type
p(
unsigned u=0)
const {
return m_g.p(u);}
222 real_type
q(
unsigned u=0)
const {
return m_g.q(u);}
224 real_type
h(
unsigned u=0)
const {
return m_g.h(u);}
226 real_type
l(
unsigned u=0)
const {
return m_g.l(u);}
228 unsigned n(
unsigned u=0)
const {
return m_g.n(u);}
230 unsigned N(
unsigned u=0)
const {
return m_g.N(u);}
232 dg::bc bc(
unsigned u=0)
const {
return m_g.bc(u);}
239 MPI_Comm
comm(
unsigned u)
const {
return m_comms.at(u);}
241 template<
size_t Md = Nd>
242 std::enable_if_t<Md==1,MPI_Comm>
comm()
const {
return m_comms.at(0);}
254 template<
size_t Md = Nd>
266 throw Error(
Message(
_ping_)<<
"u>Nd not allowed! You typed: "<<u<<
" while Nd is "<<Nd);
282 template<
size_t Md = Nd>
283 real_type
x0()
const {
return m_g.x0();}
285 template<
size_t Md = Nd>
286 real_type
x1()
const {
return m_g.x1();}
288 template<
size_t Md = Nd>
289 real_type
y0()
const {
return m_g.y0();}
291 template<
size_t Md = Nd>
292 real_type
y1()
const {
return m_g.y1();}
294 template<
size_t Md = Nd>
295 real_type
z0()
const {
return m_g.z0();}
297 template<
size_t Md = Nd>
298 real_type
z1()
const {
return m_g.z1();}
301 template<
size_t Md = Nd>
302 real_type
lx()
const {
return m_g.lx();}
304 template<
size_t Md = Nd>
305 real_type
ly()
const {
return m_g.ly();}
307 template<
size_t Md = Nd>
308 real_type
lz()
const {
return m_g.lz();}
311 template<
size_t Md = Nd>
312 real_type
hx()
const {
return m_g.hx();}
314 template<
size_t Md = Nd>
315 real_type
hy()
const {
return m_g.hy();}
317 template<
size_t Md = Nd>
318 real_type
hz()
const {
return m_g.hz();}
321 template<
size_t Md = Nd>
322 unsigned nx()
const {
return m_g.nx();}
324 template<
size_t Md = Nd>
325 unsigned ny()
const {
return m_g.ny();}
327 template<
size_t Md = Nd>
328 unsigned nz()
const {
return m_g.nz();}
331 template<
size_t Md = Nd>
332 unsigned Nx()
const {
return m_g.Nx();}
334 template<
size_t Md = Nd>
335 unsigned Ny()
const {
return m_g.Ny();}
337 template<
size_t Md = Nd>
338 unsigned Nz()
const {
return m_g.Nz();}
341 template<
size_t Md = Nd>
344 template<
size_t Md = Nd>
347 template<
size_t Md = Nd>
351 template<
size_t Md = Nd>
353 static_assert( Nd > 0);
357 template<
size_t Md = Nd>
359 static_assert( Nd > 1);
363 template<
size_t Md = Nd>
365 static_assert( Nd > 2);
371 template<
size_t Md = Nd>
374 auto Ns = m_g.get_N();
375 Ns[0] = round(fx*(real_type)m_g.N(0));
376 Ns[1] = round(fy*(real_type)m_g.N(1));
377 if( fx != 1 or fy != 1)
378 set( m_g.get_n(), Ns);
381 template<
size_t Md = Nd>
382 std::enable_if_t<(Md == 1),
void>
set(
unsigned new_n,
unsigned new_Nx)
384 set(std::array{new_n}, std::array{new_Nx});
387 template<
size_t Md = Nd>
388 std::enable_if_t<(Md == 2),
void>
set(
unsigned new_n,
unsigned new_Nx,
391 set(std::array{new_n,new_n}, std::array{new_Nx,new_Ny});
394 template<
size_t Md = Nd>
395 std::enable_if_t<(Md == 3),
void>
set(
unsigned new_n,
unsigned new_Nx,
396 unsigned new_Ny,
unsigned new_Nz)
398 set(std::array{new_n,new_n,1u}, std::array{new_Nx,new_Ny,new_Nz});
401 void set(
unsigned new_n, std::array<unsigned,Nd> new_N)
403 std::array<unsigned , Nd> tmp;
404 for(
unsigned u=0; u<Nd; u++)
409 void set_axis(
unsigned coord,
unsigned new_n ,
unsigned new_N)
411 auto n = m_g.get_n(),
N = m_g.get_N();
417 void set( std::array<unsigned,Nd> new_n, std::array<unsigned,Nd> new_N)
419 if( new_n==m_g.get_n() && new_N == m_g.get_N())
424 void set_pq( std::array<real_type,Nd> new_p, std::array<real_type,Nd> new_q)
439 unsigned size()
const {
return m_g.size();}
452 void display( std::ostream& os = std::cout)
const
454 os <<
"GLOBAL GRID \n";
456 os <<
"LOCAL GRID \n";
461 template<
size_t Md = Nd>
462 std::enable_if_t<(Md == 1),
bool>
contains( real_type x)
const
464 return m_g.contains(
x);
468 template<
class Vector>
469 bool contains(
const Vector& x)
const {
return m_g.contains(
x);}
486 if( localIdx < 0 || localIdx >= (
int)m_g.size())
return false;
488 int dims[Nd], periods[Nd], coords[Nd];
489 if( MPI_Cart_get( m_comm, Nd, dims, periods, coords) != MPI_SUCCESS)
492 if( MPI_Cart_coords( m_comm, rank, Nd, coords) != MPI_SUCCESS)
495 int current = localIdx;
496 for(
unsigned u=0; u<Nd; u++)
498 auto idx = increment(partition( m_g.N(u), dims[u]));
499 unsigned shapeu = (idx[coords[u]+1] - idx[coords[u]])*m_g.n(u);
500 int lIdx = current %shapeu;
501 current = current / shapeu;
502 gIdx[u] = lIdx + idx[coords[u]]*m_g.n(u);
504 globalIdx = gIdx[int(Nd)-1];
505 for(
int u=
int(Nd)-2; u>=0; u--)
506 globalIdx = globalIdx*m_g.shape(u) + gIdx[u];
523 if( globalIdx < 0 || globalIdx >= (
int)m_g.size())
return false;
525 int dims[Nd], periods[Nd], coords[Nd];
526 if( MPI_Cart_get( m_comm, Nd, dims, periods, coords) != MPI_SUCCESS)
529 int lIdx[Nd] = {0}, local_shape[Nd] = {0};
530 int current = globalIdx;
533 for(
unsigned u=0; u<Nd; u++)
535 int gIdx = current%(m_g.shape(u));
536 current = current / (m_g.shape(u));
537 auto idx = increment(partition( m_g.N(u), dims[u]));
539 for(
unsigned c=0; c<idx.size()-1; c++)
540 if(
unsigned(gIdx)< idx[c+1]*m_g.n(u))
543 lIdx[u] = gIdx - idx[c]*m_g.n(u);
544 local_shape[u] = (idx[c+1]-idx[c])*m_g.n(u);
548 localIdx = lIdx[int(Nd)-1];
549 for(
int u=
int(Nd)-2; u>=0; u--)
550 localIdx = localIdx*local_shape[u] + lIdx[u];
552 if( MPI_Cart_rank( m_comm, coords, &rank) == MPI_SUCCESS )
567 std::array<unsigned, Nd>
start()
const
569 int dims[Nd], periods[Nd], coords[Nd];
570 MPI_Cart_get( m_comm, Nd, dims, periods, coords);
571 std::array<unsigned, Nd>
start;
572 for(
unsigned u=0;u<Nd; u++)
574 auto idx = increment(partition( m_g.N(u), dims[u]));
575 start[Nd-1-u] = idx[coords[u]]*m_g.n(u);
587 std::array<unsigned, Nd>
count()
const {
return m_l.count(); }
608 std::array<unsigned,Nd>
n, std::array<unsigned,Nd>
N,
609 std::array<dg::bc,Nd> bcs, std::array<MPI_Comm, Nd> comms) :
610 m_g(
p,
q,
n,
N,bcs), m_comms(comms)
614 for (
unsigned u=0; u<Nd;u++)
616 MPI_Cartdim_get( m_comms[u], &ndims);
617 assert( (
unsigned)ndims == 1);
620 MPI_Cartdim_get( m_comm, &ndims);
621 assert( (
unsigned)ndims == Nd);
624 int dims[Nd], periods[Nd], coords[Nd];
625 MPI_Cart_get( m_comm, Nd, dims, periods, coords);
626 for(
unsigned u=0;u<Nd; u++)
628 auto idx = increment(partition( m_g.N(u), dims[u]));
629 N[u] = idx[coords[u]+1]-idx[coords[u]] ;
631 p[u] = m_g.p(u) + m_g.h(u)*idx[coords[u]];
632 q[u] = m_g.p(u) + m_g.h(u)*idx[coords[u] +1];
634 if( coords[u] == dims[u]-1)
637 m_l = {
p,
q, m_g.get_n(),
N, m_g.get_bc()};
642 std::array<RealGrid<real_type,1>,Nd> globals, locals;
643 for(
unsigned u=0; u<Nd; u++)
645 globals[u] = axes[u].global();
646 locals[u] = axes[u].local();
647 m_comms[u] = axes[u].communicator();
659 virtual void do_set(std::array<unsigned,Nd> new_n, std::array<unsigned,Nd> new_N) =0;
661 virtual void do_set_pq( std::array<real_type, Nd> new_p, std::array<real_type,Nd> new_q) =0;
663 virtual void do_set( std::array<dg::bc, Nd> new_bcs) =0;
695 void check_periods( std::array<dg::bc, Nd>
bc)
const
697 int rank, dims[Nd], periods[Nd], coords[Nd];
698 MPI_Cart_get( m_comm, Nd, dims, periods, coords);
699 MPI_Comm_rank( m_comm, &rank);
702 for(
unsigned u=0; u<Nd; u++)
704 if(
bc[u] ==
dg::PER) assert( periods[u] ==
true);
705 else assert( periods[u] ==
false);
709 std::vector<unsigned> partition(
unsigned N,
unsigned r)
const
712 std::vector<unsigned> points(r,
N/r );
713 for(
unsigned u=0; u<
N%r; u++)
718 std::vector<unsigned> increment(
const std::vector<unsigned>& partition)
const
723 std::vector<unsigned> inc( partition.size()+1, 0);
724 for(
unsigned u=0; u<inc.size(); u++)
725 for(
unsigned k=0; k<u; k++)
726 inc[u] += partition[k];
730 RealGrid<real_type, Nd> m_g, m_l;
731 std::array<MPI_Comm, Nd> m_comms;
737template<
class real_type,
size_t Nd>
740 m_g.set(new_n, new_N);
741 int dims[Nd], periods[Nd], coords[Nd];
742 MPI_Cart_get( m_comm, Nd, dims, periods, coords);
743 std::array<unsigned, Nd> N;
744 for(
unsigned u=0;u<Nd; u++)
746 auto idx = increment(partition( m_g.N(u), dims[u]));
747 N[u] = idx[coords[u]+1]-idx[coords[u]] ;
751template<
class real_type,
size_t Nd>
755 int dims[Nd], periods[Nd], coords[Nd];
756 MPI_Cart_get( m_comm, Nd, dims, periods, coords);
757 std::array<real_type,Nd> p, q;
758 for(
unsigned u=0;u<Nd; u++)
760 auto idx = increment(partition( m_g.N(u), dims[u]));
761 p[u] = m_g.p(u) + m_g.h(u)*idx[coords[u]];
762 q[u] = m_g.p(u) + m_g.h(u)*idx[coords[u] +1];
766template<
class real_type,
size_t Nd>
781template<
class real_type,
size_t Nd>
786 template<
size_t Md = Nd>
793 template<
size_t Md = Nd>
800 template<
size_t Md = Nd>
802 unsigned n,
unsigned Nx,
unsigned Ny, MPI_Comm
comm):
804 {
x0,
y0},{
x1,
y1},{
n,
n},{
Nx,
Ny},{
dg::PER,
dg::PER},
811 template<
size_t Md = Nd>
816 {
x0,
y0},{
x1,
y1},{
n,
n},{
Nx,
Ny},{
bcx,
bcy},
821 template<
size_t Md = Nd>
823 real_type
z0, real_type
z1,
unsigned n,
unsigned Nx,
unsigned Ny,
824 unsigned Nz, MPI_Comm
comm):
826 {
x0,
y0,
z0},{
x1,
y1,
z1},{
n,
n,1},{
Nx,
Ny,
Nz},{
dg::PER,
dg::PER,
dg::PER},
833 template<
size_t Md = Nd>
835 real_type
z0, real_type
z1,
unsigned n,
unsigned Nx,
unsigned Ny,
838 {
x0,
y0,
z0},{
x1,
y1,
z1},{
n,
n,1},{
Nx,
Ny,
Nz},{
bcx,
bcy,
bcz},
852 template<
class ...Grid1ds>
858 std::array<unsigned,Nd>
n, std::array<unsigned,Nd>
N,
859 std::array<dg::bc,Nd> bcs, std::array<MPI_Comm,Nd> comms) :
868 virtual void do_set( std::array<unsigned,Nd> new_n, std::array<unsigned,Nd> new_N)
override final{
871 virtual void do_set_pq( std::array<real_type,Nd> new_x0, std::array<real_type,Nd> new_x1)
override final{
874 virtual void do_set( std::array<dg::bc,Nd> new_bcs)
override final{
class intended for the use in throw statements
Definition exceptions.h:83
small class holding a stringstream
Definition exceptions.h:29
#define _ping_
Definition exceptions.h:12
bc
Switch between boundary conditions.
Definition enums.h:15
@ PER
periodic boundaries
Definition enums.h:16
dg::RealMPIGrid< double, 1 > MPIGrid1d
Definition mpi_grid.h:882
dg::aRealMPITopology< double, 2 > aMPITopology2d
Definition mpi_grid.h:887
dg::aRealMPITopology< double, 3 > aMPITopology3d
Definition mpi_grid.h:888
dg::RealMPIGrid< double, 3 > MPIGrid3d
Definition mpi_grid.h:884
dg::RealMPIGrid< double, 0 > MPIGrid0d
Definition mpi_grid.h:881
dg::RealMPIGrid< double, 2 > MPIGrid2d
Definition mpi_grid.h:883
std::array< MPI_Comm, Nd > mpi_cart_split_as(MPI_Comm comm)
Same as mpi_cart_split but differen return type.
Definition mpi_kron.h:272
MPI_Comm mpi_cart_kron(std::vector< MPI_Comm > comms)
Form a Kronecker product among Cartesian communicators.
Definition mpi_kron.h:178
This is the namespace for all functions and classes defined and used by the discontinuous Galerkin li...
static std::vector< real_type > abscissas(unsigned n)
Return Gauss-Legendre nodes on the interval [-1,1].
Definition dlt.h:27
static std::vector< real_type > weights(unsigned n)
Return Gauss-Legendre weights.
Definition dlt.h:83
A simple wrapper around a container object and an MPI_Comm.
Definition mpi_vector.h:37
The simplest implementation of aRealTopology.
Definition grid.h:710
The simplest implementation of aRealMPITopology3d.
Definition mpi_grid.h:783
RealMPIGrid()=default
construct an empty grid this leaves the access functions undefined
RealMPIGrid(std::array< real_type, Nd > p, std::array< real_type, Nd > q, std::array< unsigned, Nd > n, std::array< unsigned, Nd > N, std::array< dg::bc, Nd > bcs, std::array< MPI_Comm, Nd > comms)
Construct a topology directly from points and dimensions.
Definition mpi_grid.h:857
RealMPIGrid(real_type x0, real_type x1, real_type y0, real_type y1, real_type z0, real_type z1, unsigned n, unsigned Nx, unsigned Ny, unsigned Nz, MPI_Comm comm)
Construct with equal polynomial coefficients.
Definition mpi_grid.h:822
RealMPIGrid(const std::array< RealMPIGrid< real_type, 1 >, Nd > &axes)
Construct a topology as the product of 1d axes grids.
Definition mpi_grid.h:843
RealMPIGrid(real_type x0, real_type x1, unsigned n, unsigned Nx, dg::bc bcx, MPI_Comm comm)
1D grid
Definition mpi_grid.h:794
RealMPIGrid(const aRealMPITopology< real_type, Nd > &src)
Definition mpi_grid.h:865
RealMPIGrid(const RealMPIGrid< real_type, 1 > &g0, const Grid1ds &...gs)
Construct from given 1d grids Equivalent to RealMPIGrid( std::array{g0,gs...})
Definition mpi_grid.h:853
RealMPIGrid(real_type x0, real_type x1, real_type y0, real_type y1, real_type z0, real_type z1, unsigned n, unsigned Nx, unsigned Ny, unsigned Nz, dg::bc bcx, dg::bc bcy, dg::bc bcz, MPI_Comm comm)
Construct with equal polynomial coefficients.
Definition mpi_grid.h:834
RealMPIGrid(real_type x0, real_type x1, real_type y0, real_type y1, unsigned n, unsigned Nx, unsigned Ny, MPI_Comm comm)
Construct with equal polynomial coefficients.
Definition mpi_grid.h:801
RealMPIGrid(real_type x0, real_type x1, real_type y0, real_type y1, unsigned n, unsigned Nx, unsigned Ny, dg::bc bcx, dg::bc bcy, MPI_Comm comm)
Construct with equal polynomial coefficients.
Definition mpi_grid.h:812
RealMPIGrid(real_type x0, real_type x1, unsigned n, unsigned N, MPI_Comm comm)
Definition mpi_grid.h:787
An abstract base class for MPI distributed Nd-dimensional dG grids.
Definition mpi_grid.h:91
std::array< real_type, Nd > get_h() const
Get grid constant for all axes.
Definition mpi_grid.h:197
std::array< real_type, Nd > get_p() const
Get left boundary point .
Definition mpi_grid.h:185
std::enable_if_t<(Md==3), void > set(unsigned new_n, unsigned new_Nx, unsigned new_Ny, unsigned new_Nz)
Set n and N in a 3-dimensional grid.
Definition mpi_grid.h:395
std::array< host_vector, Nd > get_abscissas() const
Construct abscissas for all axes.
Definition mpi_grid.h:171
virtual void do_set(std::array< dg::bc, Nd > new_bcs)=0
Reset the boundary conditions of the grid.
std::enable_if_t<(Md >=2), void > multiplyCellNumbers(real_type fx, real_type fy)
Multiply the number of cells in the first two dimensions with a given factor.
Definition mpi_grid.h:372
std::array< unsigned, Nd > count() const
Count vector in C-order for dg::file::MPINcHyperslab.
Definition mpi_grid.h:587
real_type l(unsigned u=0) const
Get grid length for axis u.
Definition mpi_grid.h:226
real_type hz() const
Equivalent to h(2)
Definition mpi_grid.h:318
RealMPIGrid< real_type, 1 > gz() const
Equivalent to grid(2)
Definition mpi_grid.h:364
std::enable_if_t<(Md==1), bool > contains(real_type x) const
Check if the grid contains a point.
Definition mpi_grid.h:462
void set_axis(unsigned coord, unsigned new_n, unsigned new_N)
Set n and N for axis coord.
Definition mpi_grid.h:409
MPI_Comm comm(unsigned u) const
Get 1d Cartesian communicator for axis u.
Definition mpi_grid.h:239
std::array< real_type, Nd > get_l() const
Get grid length for all axes.
Definition mpi_grid.h:193
void set(std::array< unsigned, Nd > new_n, std::array< unsigned, Nd > new_N)
Set the number of polynomials and cells.
Definition mpi_grid.h:417
unsigned Ny() const
Equivalent to N(1)
Definition mpi_grid.h:335
dg::bc bcx() const
Equivalent to bc(0)
Definition mpi_grid.h:342
dg::bc bcy() const
Equivalent to bc(1)
Definition mpi_grid.h:345
std::array< unsigned, Nd > get_shape() const
the total number of points of an axis
Definition mpi_grid.h:167
unsigned shape(unsigned u=0) const
the total number of points of an axis
Definition mpi_grid.h:107
real_type z1() const
Equivalent to q(2)
Definition mpi_grid.h:298
aRealMPITopology()=default
default constructor
std::array< host_vector, Nd > get_weights() const
Construct weights for all axes.
Definition mpi_grid.h:178
~aRealMPITopology()=default
disallow deletion through base class pointer
dg::bc bc(unsigned u=0) const
Get boundary condition for axis u.
Definition mpi_grid.h:232
void set(unsigned new_n, std::array< unsigned, Nd > new_N)
Same as set( {new_n, new_n,...}, new_N);
Definition mpi_grid.h:401
aRealMPITopology(const std::array< RealMPIGrid< real_type, 1 >, Nd > &axes)
Construct a topology as the product of 1d axes grids.
Definition mpi_grid.h:640
unsigned n(unsigned u=0) const
Get number of polynomial coefficients for axis u.
Definition mpi_grid.h:228
RealMPIGrid< real_type, 1 > axis(unsigned u) const
An alias for "grid".
Definition mpi_grid.h:269
aRealMPITopology(std::array< real_type, Nd > p, std::array< real_type, Nd > q, std::array< unsigned, Nd > n, std::array< unsigned, Nd > N, std::array< dg::bc, Nd > bcs, std::array< MPI_Comm, Nd > comms)
Construct a topology directly from points and dimensions.
Definition mpi_grid.h:607
std::array< unsigned, Nd > start() const
The global start coordinate in C-order of dg::file::MPINcHyperslab that the local grid represents.
Definition mpi_grid.h:567
dg::bc bcz() const
Equivalent to bc(2)
Definition mpi_grid.h:348
unsigned size() const
The total global number of points.
Definition mpi_grid.h:439
std::enable_if_t< Md==1, MPI_Comm > comm() const
Equivalent to comm(0)
Definition mpi_grid.h:242
unsigned local_size() const
The total local number of points.
Definition mpi_grid.h:444
unsigned Nx() const
Equivalent to N(0)
Definition mpi_grid.h:332
bool contains(const Vector &x) const
Check if the grid contains a point.
Definition mpi_grid.h:469
real_type y0() const
Equivalent to p(2)
Definition mpi_grid.h:289
const RealGrid< real_type, Nd > & global() const
The global grid as a shared memory grid.
Definition mpi_grid.h:279
host_vector weights(unsigned u=0) const
Get the weights of the u axis.
Definition mpi_grid.h:153
unsigned N(unsigned u=0) const
Get number of cells for axis u.
Definition mpi_grid.h:230
real_type ly() const
Equivalent to l(1)
Definition mpi_grid.h:305
virtual void do_set(std::array< unsigned, Nd > new_n, std::array< unsigned, Nd > new_N)=0
Set the number of polynomials and cells.
std::array< real_type, Nd > get_q() const
Get right boundary point .
Definition mpi_grid.h:189
static constexpr unsigned ndim()
Dimensionality == Nd.
Definition mpi_grid.h:102
real_type value_type
value type of abscissas and weights
Definition mpi_grid.h:95
real_type y1() const
Equivalent to q(0)
Definition mpi_grid.h:292
virtual void do_set_pq(std::array< real_type, Nd > new_p, std::array< real_type, Nd > new_q)=0
Reset the boundaries of the grid.
std::array< MPI_Comm, Nd > get_comms() const
Get 1d Cartesian communicator for all axes.
Definition mpi_grid.h:217
MPI_Comm communicator() const
Return Nd dimensional MPI cartesian communicator that is used in this grid.
Definition mpi_grid.h:248
real_type lx() const
Equivalent to l(0)
Definition mpi_grid.h:302
std::enable_if_t<(Md==1), void > set(unsigned new_n, unsigned new_Nx)
Set n and N in a 1-dimensional grid.
Definition mpi_grid.h:382
std::enable_if_t<(Md >=2), MPI_Comm > get_perp_comm() const
MPI Cartesian communicator in the first two dimensions (x and y)
Definition mpi_grid.h:255
host_vector abscissas(unsigned u=0) const
Get the grid abscissas of the u axis.
Definition mpi_grid.h:120
real_type hy() const
Equivalent to h(1)
Definition mpi_grid.h:315
RealMPIGrid< real_type, 1 > gy() const
Equivalent to grid(1)
Definition mpi_grid.h:358
real_type h(unsigned u=0) const
Get grid constant for axis u.
Definition mpi_grid.h:224
real_type z0() const
Equivalent to q(1)
Definition mpi_grid.h:295
std::array< dg::bc, Nd > get_bc() const
Get boundary condition for all axes.
Definition mpi_grid.h:211
RealMPIGrid< real_type, 1 > gx() const
Equivalent to grid(0)
Definition mpi_grid.h:352
std::array< unsigned, Nd > get_n() const
Get number of polynomial coefficients for all axes.
Definition mpi_grid.h:206
void display(std::ostream &os=std::cout) const
Display global and local grid paramters.
Definition mpi_grid.h:452
real_type x0() const
Equivalent to p(0)
Definition mpi_grid.h:283
real_type lz() const
Equivalent to l(2)
Definition mpi_grid.h:308
void set_pq(std::array< real_type, Nd > new_p, std::array< real_type, Nd > new_q)
Reset the boundaries of the grid.
Definition mpi_grid.h:424
aRealMPITopology(const aRealMPITopology &src)=default
real_type hx() const
Equivalent to h(0)
Definition mpi_grid.h:312
aRealMPITopology & operator=(const aRealMPITopology &src)=default
std::array< unsigned, Nd > get_N() const
Get number of cells for all axes.
Definition mpi_grid.h:201
unsigned nx() const
Equivalent to n(0)
Definition mpi_grid.h:322
unsigned Nz() const
Equivalent to N(2)
Definition mpi_grid.h:338
bool global2localIdx(int globalIdx, int &localIdx, int &rank) const
Convert the global index of a vector to a local index and the rank of the containing process.
Definition mpi_grid.h:520
const RealGrid< real_type, Nd > & local() const
The local grid as a shared memory grid.
Definition mpi_grid.h:274
RealMPIGrid< real_type, 1 > grid(unsigned u) const
Get axis u as a 1d grid.
Definition mpi_grid.h:262
void set_bcs(std::array< dg::bc, Nd > new_bcs)
Reset the boundary conditions of the grid.
Definition mpi_grid.h:429
std::enable_if_t<(Md==2), void > set(unsigned new_n, unsigned new_Nx, unsigned new_Ny)
Set n and N in a 2-dimensional grid.
Definition mpi_grid.h:388
real_type p(unsigned u=0) const
Get left boundary point for axis u.
Definition mpi_grid.h:220
real_type q(unsigned u=0) const
Get right boundary point for axis u.
Definition mpi_grid.h:222
real_type x1() const
Equivalent to p(1)
Definition mpi_grid.h:286
unsigned ny() const
Equivalent to n(1)
Definition mpi_grid.h:325
bool local2globalIdx(int localIdx, int rank, int &globalIdx) const
Convert the index of a local vector and the rank of the containing process to a global index.
Definition mpi_grid.h:481
unsigned nz() const
Equivalent to n(2)
Definition mpi_grid.h:328