27template<
class real_type>
28thrust::host_vector<real_type> normalize_weights_and_compute_abscissas(
const RealGrid1d<real_type>& g, thrust::host_vector<real_type>& weights)
31 unsigned Nx_new =
weights.size()/g.n();
32 for(
unsigned i=0;i<
weights.size(); i++)
33 weights[i] *= (real_type)g.N()/(real_type)Nx_new;
35 thrust::host_vector<real_type> boundaries(Nx_new+1), abs(g.n()*Nx_new);
36 boundaries[0] = g.x0();
37 for(
unsigned i=0; i<Nx_new; i++)
39 boundaries[i+1] = boundaries[i] + g.lx()/(real_type)Nx_new/weights[g.n()*i];
40 for(
unsigned j=0; j<g.n(); j++)
42 abs[i*g.n()+j] = (boundaries[i+1]+boundaries[i])/2. +
58template<
class real_type>
69 weights.resize(
N_new(g_old.
N(), g_old.
bcx()));
70 abscissas.resize(
N_new(g_old.
N(), g_old.
bcx()));
71 do_generate(g_old,weights,abscissas);
77 unsigned N_new(
unsigned N_old,
bc bcx)
const
79 return do_N_new(N_old, bcx);
88 virtual void do_generate(
const RealGrid1d<real_type>& g, thrust::host_vector<real_type>& weights, thrust::host_vector<real_type>& abscissas)
const =0;
89 virtual unsigned do_N_new(
unsigned N_old,
bc bcx)
const =0;
95template<
class real_type>
100 virtual void do_generate(
const RealGrid1d<real_type>& g, thrust::host_vector<real_type>& weights, thrust::host_vector<real_type>& abscissas)
const override final{
102 abscissas=g.abscissas(0);
104 virtual unsigned do_N_new(
unsigned N_old,
bc bcx)
const override final{
112template<
class real_type>
120 assert( multiple>= 1);
125 virtual void do_generate(
const RealGrid1d<real_type>& g, thrust::host_vector<real_type>& weights, thrust::host_vector<real_type>& abscissas)
const override final
127 thrust::host_vector< real_type> left( g.n()*g.N()*m_, 1);
128 for(
unsigned k=0; k<left.size(); k++)
129 left[k] = (real_type)m_;
131 abscissas = dg::detail::normalize_weights_and_compute_abscissas( g, weights);
133 virtual unsigned do_N_new(
unsigned N_old,
bc bcx)
const override final{
150template<
class real_type>
158 assert( multiple>= 1);
163 std::vector<real_type> simpsons_weights(
unsigned N,
double h)
const
167 std::vector<real_type> simpson( N, h);
170 simpson[0] = simpson[1] = h/2.;
173 simpson[0]=1./3. * h;
174 for(
unsigned i=0; i<(N-3)/2; i++)
176 simpson[2*i+1] = 4./3. * h;
177 simpson[2*i+2] = 2./3. * h;
181 simpson[N-2] = 4./3. * h;
182 simpson[N-1] = 1./3. * h;
186 simpson[N-4] = N==4 ? 3./8.*h : (1./3.+3./8.)*h;
187 simpson[N-3] = (9./8.)*h;
188 simpson[N-2] = (9./8.)*h;
189 simpson[N-1] = (3./8.)*h;
193 virtual void do_generate(
const RealGrid1d<real_type>& g, thrust::host_vector<real_type>& weights, thrust::host_vector<real_type>& abscissas)
const override final
195 thrust::host_vector<real_type> old = g.abscissas(0);
202 abscissas.resize( g.size()*m_M);
205 unsigned NLeft = m_M/2;
206 double hxleft = (old[0] - g.x0())/(double)(NLeft+1);
207 abscissas[0] = g.x0()+hxleft;
210 std::vector<real_type> sim = simpsons_weights( NLeft+1, hxleft);
212 for(
unsigned k=1; k<=NLeft; k++)
215 abscissas[idx] = abscissas[idx-1]+hxleft;
219 unsigned NMiddle = m_M;
220 for(
unsigned i=0; i<old.size()-1; i++)
222 double hxmiddle = (old[i+1] - old[i])/(
double)NMiddle;
223 sim = simpsons_weights( NMiddle+1, hxmiddle);
225 for(
unsigned k=1; k<=NMiddle; k++)
228 abscissas[idx] = abscissas[idx-1]+hxmiddle;
232 unsigned NRight = m_M - 1 - m_M/2;
233 double hxright = (g.x1() - old[g.size()-1] )/(double)(NRight+1);
236 sim = simpsons_weights( NRight+1, hxright);
238 for(
unsigned k=1; k<=NRight; k++)
241 abscissas[idx] = abscissas[idx-1]+hxright;
250 virtual unsigned do_N_new(
unsigned N_old,
bc bcx)
const override final{
258template<
class real_type>
270 RealEquidistRefinement(
unsigned add_x,
unsigned node,
unsigned howmany=1): add_x_(add_x), node_(node), howm_(howmany){ }
273 unsigned add_x_, node_, howm_;
274 virtual void do_generate(
const RealGrid1d<real_type>& g, thrust::host_vector<real_type>& weights, thrust::host_vector<real_type>& abscissas)
const override final
276 if( add_x_ == 0 || howm_ == 0)
278 thrust::host_vector<real_type> w_( g.size(), 1);
279 abscissas = g.abscissas(0);
283 weights = equidist_ref( add_x_, node_, g.n(), g.N(), g.bcx(), howm_);
284 abscissas = detail::normalize_weights_and_compute_abscissas( g, weights);
286 virtual unsigned do_N_new(
unsigned N_old,
bc bcx)
const override final
288 if( bcx ==
dg::PER)
return N_old + 2*add_x_*howm_;
289 return N_old + add_x_*howm_;
291 thrust::host_vector<real_type> equidist_ref(
unsigned add_x,
unsigned node,
unsigned n,
unsigned N,
dg::bc bcx,
unsigned howmany)
const
295 if( node_ != 0 && node_ != N)
296 assert( howm_ <= node_ && howm_ <= N-node_);
297 if( add_x_ == 0 || howm_ == 0)
299 thrust::host_vector<real_type> w_( n*N, 1);
303 thrust::host_vector< real_type> left( n*N+n*add_x_*howm_, 1), right(left);
304 for(
unsigned i=0; i<(add_x_+1)*howm_; i++)
305 for(
unsigned k=0; k<n; k++)
306 left[i*n+k] = add_x_ + 1;
308 for(
unsigned i=0; i<right.size(); i++)
309 right[i] = left[ (left.size()-1)-i];
310 thrust::host_vector< real_type> both( n*N+2*n*add_x_*howm_, 1);
311 for(
unsigned i=0; i<left.size(); i++)
313 for(
unsigned i=0; i<right.size(); i++)
314 both[i+n*add_x_*howm_] *= right[i];
315 if( node_ == 0 && bcx !=
dg::PER) {
return left; }
316 else if( node_ == N && bcx !=
dg::PER) {
return right; }
317 else if((node_ == N || node_ == 0) && bcx ==
dg::PER) {
return both; }
320 thrust::host_vector<real_type> w_ = both;
322 for(
unsigned i=0; i<both.size(); i++)
323 w_[((howm_*add_x_+node_)*n+i)%both.size()] = both[i];
333template<
class real_type>
348 unsigned add_x_, node_;
349 virtual void do_generate(
const RealGrid1d<real_type>& g, thrust::host_vector<real_type>& weights, thrust::host_vector<real_type>& abscissas)
const override final
353 thrust::host_vector<real_type> w_( g.size(), 1);
354 abscissas= g.abscissas(0);
358 weights = exponential_ref( add_x_, node_, g.n(), g.N(), g.bcx());
359 abscissas = detail::normalize_weights_and_compute_abscissas( g, weights);
361 virtual unsigned do_N_new(
unsigned N_old,
bc bcx)
const override final
363 if( bcx ==
dg::PER)
return N_old + 2*add_x_;
364 return N_old + add_x_;
366 thrust::host_vector<real_type> exponential_ref(
unsigned add_x,
unsigned node,
unsigned n,
unsigned N,
dg::bc bcx)
const
370 thrust::host_vector<real_type> w_( n*N, 1);
375 thrust::host_vector< real_type> left( n*N+n*add_x_, 1), right(left);
376 for(
unsigned k=0; k<n; k++)
377 left[k] = pow( 2, add_x_);
378 for(
unsigned i=0; i<add_x_; i++)
379 for(
unsigned k=0; k<n; k++)
380 left[(i+1)*n+k] = pow( 2, add_x_-i);
382 for(
unsigned i=0; i<right.size(); i++)
383 right[i] = left[ (left.size()-1)-i];
384 thrust::host_vector< real_type> both( n*N+2*n*add_x_, 1);
385 for(
unsigned i=0; i<left.size(); i++)
387 for(
unsigned i=0; i<right.size(); i++)
388 both[i+n*add_x_] *= right[i];
389 if( node_ == 0 && bcx !=
dg::PER) {
return left; }
390 else if( node_ == N && bcx !=
dg::PER) {
return right; }
391 else if((node_ == N || node_ == 0) && bcx ==
dg::PER) {
return both; }
394 thrust::host_vector<real_type> w_ = both;
396 for(
unsigned i=0; i<both.size(); i++)
397 w_[((add_x_+node_)*n+i)%both.size()] = both[i];
416template<
class real_type>
421 dg::
aGeometry2d( {
x0,
y0},{
x1,
y1}, {
n,
n},{refX.N_new(
Nx,
bcx),refY.N_new(
Ny,
bcy)}, {
bcx,
bcy}),
422 refX_(refX), refY_(refY), w_(2), a_(2)
424 construct_weights_and_abscissas(
n,
Nx,
n,
Ny);
430 std::vector<thrust::host_vector<real_type> > w_, a_;
431 void construct_weights_and_abscissas(
unsigned nx,
unsigned Nx,
unsigned ny,
unsigned Ny)
435 thrust::host_vector<real_type> wx, ax, wy, ay;
436 refX_->generate(
gx, wx, ax);
437 refY_->generate(
gy, wy, ay);
438 w_[0].resize(this->
size()), w_[1].resize(this->
size());
439 a_[0].resize(this->
size()), a_[1].resize(this->
size());
441 for(
unsigned i=0; i<wy.size(); i++)
442 for(
unsigned j=0; j<wx.size(); j++)
444 w_[0][i*wx.size()+j] = wx[j];
445 w_[1][i*wx.size()+j] = wy[i];
446 a_[0][i*wx.size()+j] = ax[j];
447 a_[1][i*wx.size()+j] = ay[i];
450 virtual void do_set(std::array<unsigned,2> new_n, std::array<unsigned,2> new_N)
override final{
451 unsigned Nx = new_N[0],
Ny = new_N[1];
453 refY_->N_new(
Ny,this->
bcy())});
454 construct_weights_and_abscissas(new_n[0],
Nx, new_n[1],
Ny);
456 virtual void do_set(std::array<dg::bc,2> new_bc)
override final
460 virtual void do_set_pq(std::array<real_type,2> new_x0, std::array<real_type,2> new_x1)
override final
464 virtual SparseTensor<thrust::host_vector<real_type> > do_compute_metric()const override final{
465 SparseTensor<thrust::host_vector<real_type> > t(*
this);
466 t.values().push_back( w_[0]);
467 t.values().push_back( w_[1]);
470 t.idx(0,0)=2, t.idx(1,1)=3;
473 virtual SparseTensor<thrust::host_vector<real_type> > do_compute_jacobian()const override final{
474 SparseTensor<thrust::host_vector<real_type> > t(*
this);
475 t.values().push_back( w_[0]);
476 t.values().push_back( w_[1]);
477 t.idx(0,0)=2, t.idx(1,1)=3;
480 virtual std::vector<thrust::host_vector<real_type> > do_compute_map()const override final{
489template<
class real_type>
496 refX_(refX), refY_(refY), refZ_(refZ), w_(3), a_(3)
498 construct_weights_and_abscissas(
n,
Nx,
n,
Ny,1,
Nz);
504 std::vector<thrust::host_vector<real_type> > w_, a_;
505 void construct_weights_and_abscissas(
unsigned nx,
unsigned Nx,
unsigned ny,
unsigned Ny,
unsigned nz,
unsigned Nz)
510 thrust::host_vector<real_type> w[3], a[3];
511 refX_->generate(
gx, w[0], a[0]);
512 refY_->generate(
gy, w[1], a[1]);
513 refZ_->generate(
gz, w[2], a[2]);
514 w_[0].resize(this->
size()), w_[1].resize(this->
size()), w_[2].resize(this->
size());
515 a_[0].resize(this->
size()), a_[1].resize(this->
size()), a_[2].resize(this->
size());
517 for(
unsigned s=0; s<w[2].size(); s++)
518 for(
unsigned i=0; i<w[1].size(); i++)
519 for(
unsigned j=0; j<w[0].size(); j++)
521 w_[0][(s*w[1].size()+i)*w[0].size()+j] = w[0][j];
522 w_[1][(s*w[1].size()+i)*w[0].size()+j] = w[1][i];
523 w_[2][(s*w[1].size()+i)*w[0].size()+j] = w[2][s];
524 a_[0][(s*w[1].size()+i)*w[0].size()+j] = a[0][j];
525 a_[1][(s*w[1].size()+i)*w[0].size()+j] = a[1][i];
526 a_[2][(s*w[1].size()+i)*w[0].size()+j] = a[1][s];
529 virtual void do_set(std::array<unsigned,3> new_n, std::array<unsigned,3> new_N)
override final{
530 unsigned Nx = new_N[0],
Ny = new_N[1],
Nz = new_N[2];
532 refY_->N_new(
Ny,this->
bcy()),
533 refZ_->N_new(
Nz,this->
bcz())});
534 construct_weights_and_abscissas(new_n[0],
Nx, new_n[1],
Ny, new_n[2],
Nz);
536 virtual void do_set(std::array<dg::bc,3> new_bc)
override final
540 virtual void do_set_pq(std::array<real_type,3> new_x0, std::array<real_type,3> new_x1)
override final
544 virtual SparseTensor<thrust::host_vector<real_type> > do_compute_metric()const override final {
545 SparseTensor<thrust::host_vector<real_type> > t(*
this);
546 t.values().resize( 4, t.values()[0]);
550 t.idx(0,0)=1, t.idx(1,1)=2, t.idx(2,2)=3;
553 virtual SparseTensor<thrust::host_vector<real_type> > do_compute_jacobian()const override final{
554 SparseTensor<thrust::host_vector<real_type> > t(*
this);
555 t.values().push_back( w_[0]);
556 t.values().push_back( w_[1]);
557 t.values().push_back( w_[2]);
558 t.idx(0,0)=2, t.idx(1,1)=3, t.idx(2,2)=4;
561 virtual std::vector<thrust::host_vector<real_type> > do_compute_map()const 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
DG_DEVICE T one(T x, Ts ...xs)
Definition functions.h:24
void copy(const ContainerTypeIn &source, ContainerTypeOut &target)
Definition blas1.h:243
void pointwiseDot(value_type alpha, const ContainerType1 &x1, const ContainerType2 &x2, value_type1 beta, ContainerType &y)
Definition blas1.h:406
void pointwiseDivide(value_type alpha, const ContainerType1 &x1, const ContainerType2 &x2, value_type1 beta, ContainerType &y)
Definition blas1.h:495
bc
Switch between boundary conditions.
Definition enums.h:15
@ PER
periodic boundaries
Definition enums.h:16
auto weights(const Topology &g)
Nodal weight coefficients.
Definition weights.h:62
auto evaluate(Functor &&f, const Topology &g)
Evaluate a function on grid coordinates
Definition evaluation.h:74
dg::RealGrid< T, 1 > RealGrid1d
Definition grid.h:798
Interpolation matrix creation functions.
This is the namespace for all functions and classes defined and used by the discontinuous Galerkin li...
Manager class that invokes the clone() method on the managed ptr when copied.
Definition memory.h:21
static std::vector< real_type > abscissas(unsigned n)
Return Gauss-Legendre nodes on the interval [-1,1].
Definition dlt.h:27
Refined RealCartesian grid.
Definition refined_grid.h:418
RealCartesianRefinedGrid2d(const aRealRefinement1d< real_type > &refX, const aRealRefinement1d< real_type > &refY, real_type x0, real_type x1, real_type y0, real_type y1, unsigned n, unsigned Nx, unsigned Ny, bc bcx=dg::PER, bc bcy=dg::PER)
Definition refined_grid.h:419
virtual RealCartesianRefinedGrid2d * clone() const
Geometries are cloneable.
Definition refined_grid.h:427
Refined RealCartesian grid.
Definition refined_grid.h:491
RealCartesianRefinedGrid3d(const aRealRefinement1d< real_type > &refX, const aRealRefinement1d< real_type > &refY, aRealRefinement1d< real_type > &refZ, 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, bc bcx=dg::PER, bc bcy=dg::PER, bc bcz=dg::PER)
Definition refined_grid.h:492
virtual RealCartesianRefinedGrid3d * clone() const
Geometries are cloneable.
Definition refined_grid.h:501
Cell refinement around a given node.
Definition refined_grid.h:260
RealEquidistRefinement(unsigned add_x, unsigned node, unsigned howmany=1)
Divide a number of cells left and right of a node into an equidistant number of new cells.
Definition refined_grid.h:270
virtual RealEquidistRefinement * clone() const
Definition refined_grid.h:271
The exponential refinement around a node.
Definition refined_grid.h:335
virtual RealExponentialRefinement * clone() const
Definition refined_grid.h:346
RealExponentialRefinement(unsigned add_x, unsigned node)
Construct exponential refinement.
Definition refined_grid.h:345
Insert equidistant points in between dG nodes.
Definition refined_grid.h:152
RealFemRefinement(unsigned multiple)
Refine every cell in the grid by an integer number of new cells.
Definition refined_grid.h:157
virtual RealFemRefinement * clone() const
Definition refined_grid.h:160
The simplest implementation of aRealTopology.
Definition grid.h:710
No refinement.
Definition refined_grid.h:97
virtual RealIdentityRefinement * clone() const
Definition refined_grid.h:98
Multiply every cell in the grid by a factor.
Definition refined_grid.h:114
RealLinearRefinement(unsigned multiple)
Refine every cell in the grid by an integer number of new cells.
Definition refined_grid.h:119
virtual RealLinearRefinement * clone() const
Definition refined_grid.h:122
This is the abstract interface class for a two-dimensional Geometry.
Definition base_geometry.h:15
This is the abstract interface class for a three-dimensional Geometry.
Definition base_geometry.h:90
Abstract base class for 1d grid refinement that increases the number of grid cells of a fixed basis g...
Definition refined_grid.h:60
aRealRefinement1d(const aRealRefinement1d &src)=default
virtual aRealRefinement1d * clone() const =0
aRealRefinement1d & operator=(const aRealRefinement1d &src)=default
aRealRefinement1d()=default
void generate(const RealGrid1d< real_type > &g_old, thrust::host_vector< real_type > &weights, thrust::host_vector< real_type > &abscissas) const
Generate the grid transformation.
Definition refined_grid.h:67
virtual ~aRealRefinement1d()=default
unsigned N_new(unsigned N_old, bc bcx) const
the new number of cells
Definition refined_grid.h:77
dg::bc bcz() const
Definition grid.h:350
RealGrid< real_type, 1 > gy() const
Definition grid.h:360
unsigned nz() const
Definition grid.h:330
real_type x0() const
Definition grid.h:285
unsigned ny() const
Definition grid.h:327
RealGrid< real_type, 1 > gx() const
Definition grid.h:354
real_type z1() const
Definition grid.h:300
unsigned size() const
Definition grid.h:532
dg::bc bcy() const
Definition grid.h:347
real_type z0() const
Definition grid.h:297
unsigned n(unsigned u=0) const
Definition grid.h:262
unsigned Nx() const
Definition grid.h:334
unsigned nx() const
Definition grid.h:324
real_type y0() const
Definition grid.h:291
virtual void do_set(std::array< unsigned, Nd > new_n, std::array< unsigned, Nd > new_N)=0
Set the number of polynomials and cells.
RealGrid< real_type, 1 > gz() const
Definition grid.h:366
real_type y1() const
Definition grid.h:294
real_type x1() const
Definition grid.h:288
dg::bc bcx() const
Equivalent to bc(0)
Definition grid.h:344
unsigned Ny() const
Definition grid.h:337
unsigned Nz() const
Definition grid.h:340
unsigned N(unsigned u=0) const
Get number of cells for axis u.
Definition grid.h:265
Creation functions for integration weights and their inverse.