Discontinuous Galerkin Library
#include "dg/algorithm.h"
Loading...
Searching...
No Matches
refined_grid.h
Go to the documentation of this file.
1#pragma once
2
3#include "dg/backend/memory.h"
4#include "dg/blas.h"
5#include "grid.h"
6#include "weights.h"
7#include "interpolation.h"
8
9#include "base_geometry.h"
10
11
12namespace dg
13{
14
16namespace detail
17{
18
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)
29{
30 //normalize 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;
34
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++)
38 {
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++)
41 {
42 abs[i*g.n()+j] = (boundaries[i+1]+boundaries[i])/2. +
43 (boundaries[i+1]-boundaries[i])/2.*dg::DLT<real_type>::abscissas(g.n())[j];
44 }
45 }
46 return abs;
47}
48
49}//namespace detail
51
54
58template<class real_type>
60{
67 void generate( const RealGrid1d<real_type>& g_old, thrust::host_vector<real_type>& weights, thrust::host_vector<real_type>& abscissas) const
68 {
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);
72 }
77 unsigned N_new( unsigned N_old, bc bcx) const
78 {
79 return do_N_new(N_old, bcx);
80 }
81 virtual aRealRefinement1d* clone()const=0;
82 virtual ~aRealRefinement1d() = default;
83 protected:
84 aRealRefinement1d() = default;
85 aRealRefinement1d(const aRealRefinement1d& src) = default;
87 private:
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;
90};
91
95template<class real_type>
96struct RealIdentityRefinement : public aRealRefinement1d<real_type>
97{
99 private:
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{
101 weights=dg::create::weights(g);
102 abscissas=g.abscissas(0);
103 }
104 virtual unsigned do_N_new( unsigned N_old, bc bcx) const override final{
105 return N_old;
106 }
107};
108
112template<class real_type>
113struct RealLinearRefinement : public aRealRefinement1d<real_type>
114{
119 RealLinearRefinement( unsigned multiple): m_(multiple){
120 assert( multiple>= 1);
121 }
122 virtual RealLinearRefinement* clone()const{return new RealLinearRefinement(*this);}
123 private:
124 unsigned m_;
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
126 {
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_;
130 weights = left;
131 abscissas = dg::detail::normalize_weights_and_compute_abscissas( g, weights);
132 }
133 virtual unsigned do_N_new( unsigned N_old, bc bcx) const override final{
134 return N_old*m_;
135 }
136};
137
150template<class real_type>
151struct RealFemRefinement : public aRealRefinement1d<real_type>
152{
157 RealFemRefinement( unsigned multiple): m_M(multiple){
158 assert( multiple>= 1);
159 }
160 virtual RealFemRefinement* clone()const{return new RealFemRefinement(*this);}
161 private:
162 unsigned m_M;
163 std::vector<real_type> simpsons_weights( unsigned N, double h) const
164 {
165 // Create weights for Simpson's integration on an equidistant subgrid with N cells (including end points)
166 // N >= 2
167 std::vector<real_type> simpson( N, h);
168 if( N == 2)
169 {
170 simpson[0] = simpson[1] = h/2.;
171 return simpson;
172 }
173 simpson[0]=1./3. * h;
174 for( unsigned i=0; i<(N-3)/2; i++)
175 {
176 simpson[2*i+1] = 4./3. * h;
177 simpson[2*i+2] = 2./3. * h;
178 }
179 if( N%2 != 0)
180 {
181 simpson[N-2] = 4./3. * h;
182 simpson[N-1] = 1./3. * h;
183 }
184 else
185 {
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;
190 }
191 return simpson;
192 }
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
194 {
195 thrust::host_vector<real_type> old = g.abscissas(0);
196 if( m_M == 1)
197 {
198 abscissas = old;
200 return;
201 }
202 abscissas.resize( g.size()*m_M);
203 weights.resize( g.size()*m_M);
204 dg::blas1::copy( 0., weights);
205 unsigned NLeft = m_M/2;
206 double hxleft = (old[0] - g.x0())/(double)(NLeft+1);
207 abscissas[0] = g.x0()+hxleft;
208 weights[0] = hxleft;
209 unsigned idx = 0;
210 std::vector<real_type> sim = simpsons_weights( NLeft+1, hxleft);
211 weights[idx] += sim[0];
212 for( unsigned k=1; k<=NLeft; k++)
213 {
214 idx++;
215 abscissas[idx] = abscissas[idx-1]+hxleft;
216 weights[idx] += sim[k];
217 }
218 // now abs is at old[0]
219 unsigned NMiddle = m_M;
220 for( unsigned i=0; i<old.size()-1; i++)
221 {
222 double hxmiddle = (old[i+1] - old[i])/(double)NMiddle;
223 sim = simpsons_weights( NMiddle+1, hxmiddle);
224 weights[idx] += sim[0];
225 for( unsigned k=1; k<=NMiddle; k++)
226 {
227 idx++;
228 abscissas[idx] = abscissas[idx-1]+hxmiddle;
229 weights[idx] += sim[k];
230 }
231 }
232 unsigned NRight = m_M - 1 - m_M/2;
233 double hxright = (g.x1() - old[g.size()-1] )/(double)(NRight+1);
234 if( NRight > 0)
235 {
236 sim = simpsons_weights( NRight+1, hxright);
237 weights[idx] += sim[0];
238 for( unsigned k=1; k<=NRight; k++)
239 {
240 idx++;
241 abscissas[idx] = abscissas[idx-1]+hxright;
242 weights[idx] += sim[k];
243 }
244 }
245 weights[idx] += hxright;
246 RealGrid1d<real_type> nGrid( g.x0(), g.x1(), g.n(), g.N()*m_M);
247 thrust::host_vector<real_type> wrong_weights = dg::create::weights(nGrid);
248 dg::blas1::pointwiseDivide( wrong_weights, weights, weights);
249 }
250 virtual unsigned do_N_new( unsigned N_old, bc bcx) const override final{
251 return N_old*m_M;
252 }
253};
254
258template<class real_type>
260{
270 RealEquidistRefinement( unsigned add_x, unsigned node, unsigned howmany=1): add_x_(add_x), node_(node), howm_(howmany){ }
271 virtual RealEquidistRefinement* clone()const{return new RealEquidistRefinement(*this);}
272 private:
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
275 {
276 if( add_x_ == 0 || howm_ == 0)
277 {
278 thrust::host_vector<real_type> w_( g.size(), 1);
279 abscissas = g.abscissas(0);
280 weights = w_;
281 return;
282 }
283 weights = equidist_ref( add_x_, node_, g.n(), g.N(), g.bcx(), howm_);
284 abscissas = detail::normalize_weights_and_compute_abscissas( g, weights);
285 }
286 virtual unsigned do_N_new( unsigned N_old, bc bcx) const override final
287 {
288 if( bcx == dg::PER) return N_old + 2*add_x_*howm_;
289 return N_old + add_x_*howm_;
290 }
291 thrust::host_vector<real_type> equidist_ref( unsigned add_x, unsigned node, unsigned n, unsigned N, dg::bc bcx, unsigned howmany) const
292 {
293 assert( howm_ <= N);
294 assert( node_ <= N);
295 if( node_ != 0 && node_ != N)
296 assert( howm_ <= node_ && howm_ <= N-node_);
297 if( add_x_ == 0 || howm_ == 0)
298 {
299 thrust::host_vector<real_type> w_( n*N, 1);
300 return w_;
301 }
302 //there are add_x+1 finer cells per refined cell ...
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++)//the original cell and the additional ones
305 for( unsigned k=0; k<n; k++)
306 left[i*n+k] = add_x_ + 1;
307 //mirror left into right
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++)
312 both[i] *= left[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; }
318 else
319 {
320 thrust::host_vector<real_type> w_ = both;
321 //now shift indices so that refinement is around node_s
322 for( unsigned i=0; i<both.size(); i++)
323 w_[((howm_*add_x_+node_)*n+i)%both.size()] = both[i];
324 return w_;
325 }
326 }
327
328};
329
333template<class real_type>
335{
345 RealExponentialRefinement( unsigned add_x, unsigned node): add_x_(add_x), node_(node) {}
347 private:
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
350 {
351 if( add_x_ == 0)
352 {
353 thrust::host_vector<real_type> w_( g.size(), 1);
354 abscissas= g.abscissas(0);
355 weights = w_;
356 return;
357 }
358 weights = exponential_ref( add_x_, node_, g.n(), g.N(), g.bcx());
359 abscissas = detail::normalize_weights_and_compute_abscissas( g, weights);
360 }
361 virtual unsigned do_N_new( unsigned N_old, bc bcx) const override final
362 {
363 if( bcx == dg::PER) return N_old + 2*add_x_;
364 return N_old + add_x_;
365 }
366 thrust::host_vector<real_type> exponential_ref( unsigned add_x, unsigned node, unsigned n, unsigned N, dg::bc bcx) const
367 {
368 if( add_x_ == 0)
369 {
370 thrust::host_vector<real_type> w_( n*N, 1);
371 return w_;
372 }
373 assert( node_ <= N);
374 //there are add_x_+1 finer cells per refined cell ...
375 thrust::host_vector< real_type> left( n*N+n*add_x_, 1), right(left);
376 for( unsigned k=0; k<n; k++)//the original cell and the additional ones
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);
381 //mirror left into right
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++)
386 both[i] *= left[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; }
392 else
393 {
394 thrust::host_vector<real_type> w_ = both;
395 //now shift indices so that refinement is around node_s
396 for( unsigned i=0; i<both.size(); i++)
397 w_[((add_x_+node_)*n+i)%both.size()] = both[i];
398 return w_;
399 }
400 }
401};
402
409
411
416template<class real_type>
418{
419 RealCartesianRefinedGrid2d( const aRealRefinement1d<real_type>& refX, const aRealRefinement1d<real_type>& refY, real_type x0, real_type x1, real_type y0, real_type y1,
420 unsigned n, unsigned Nx, unsigned Ny, bc bcx = dg::PER, bc bcy = dg::PER) :
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)
423 {
424 construct_weights_and_abscissas(n,Nx,n,Ny);
425 }
426
428 private:
430 std::vector<thrust::host_vector<real_type> > w_, a_;
431 void construct_weights_and_abscissas(unsigned nx, unsigned Nx, unsigned ny, unsigned Ny)
432 {
433 RealGrid1d<real_type> gx( this->x0(), this->x1(), nx, Nx, this->bcx());
434 RealGrid1d<real_type> gy( this->y0(), this->y1(), ny, Ny, this->bcy());
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());
440 //now make product space
441 for( unsigned i=0; i<wy.size(); i++)
442 for( unsigned j=0; j<wx.size(); j++)
443 {
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];
448 }
449 }
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];
452 aRealTopology2d<real_type>::do_set(new_n,{refX_->N_new(Nx,this->bcx()),
453 refY_->N_new(Ny,this->bcy())});
454 construct_weights_and_abscissas(new_n[0], Nx, new_n[1], Ny);
455 }
456 virtual void do_set(std::array<dg::bc,2> new_bc) override final
457 {
459 }
460 virtual void do_set_pq(std::array<real_type,2> new_x0, std::array<real_type,2> new_x1) override final
461 {
462 throw dg::Error(dg::Message(_ping_)<<"This grid cannot change boundaries\n");
463 }
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]);
468 dg::blas1::pointwiseDot( w_[0], w_[0], t.values()[2]);
469 dg::blas1::pointwiseDot( w_[1], w_[1], t.values()[3]);
470 t.idx(0,0)=2, t.idx(1,1)=3;
471 return t;
472 }
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;
478 return t;
479 }
480 virtual std::vector<thrust::host_vector<real_type> > do_compute_map()const override final{
481 return a_;
482 }
483};
484
489template< class real_type>
491{
492 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,
493 unsigned n, unsigned Nx, unsigned Ny, unsigned Nz, bc bcx = dg::PER, bc bcy = dg::PER, bc bcz=dg::PER) :
494 dg::aGeometry3d( {x0,y0,z0},{x1,y1,z1}, {n,n,1},
495 {refX.N_new(Nx,bcx),refY.N_new(Ny,bcy),refZ.N_new(Nz,bcz)}, {bcx,bcy,bcz}),
496 refX_(refX), refY_(refY), refZ_(refZ), w_(3), a_(3)
497 {
498 construct_weights_and_abscissas(n, Nx, n, Ny,1, Nz);
499 }
500
502 private:
503 ClonePtr<aRealRefinement1d<real_type>> refX_, refY_, refZ_;
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)
506 {
507 RealGrid1d<real_type> gx( this->x0(), this->x1(), nx, Nx, this->bcx());
508 RealGrid1d<real_type> gy( this->y0(), this->y1(), ny, Ny, this->bcy());
509 RealGrid1d<real_type> gz( this->y0(), this->y1(), nz, Nz, this->bcz());
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());
516 //now make product space
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++)
520 {
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];
527 }
528 }
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];
531 aRealTopology3d<real_type>::do_set(new_n,{refX_->N_new(Nx,this->bcx()),
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);
535 }
536 virtual void do_set(std::array<dg::bc,3> new_bc) override final
537 {
539 }
540 virtual void do_set_pq(std::array<real_type,3> new_x0, std::array<real_type,3> new_x1) override final
541 {
542 throw dg::Error(dg::Message(_ping_)<<"This grid cannot change boundaries\n");
543 }
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]);
547 dg::blas1::pointwiseDot( w_[0], w_[0], t.values()[1]);
548 dg::blas1::pointwiseDot( w_[1], w_[1], t.values()[2]);
549 dg::blas1::pointwiseDot( w_[2], w_[2], t.values()[3]);
550 t.idx(0,0)=1, t.idx(1,1)=2, t.idx(2,2)=3;
551 return t;
552 }
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;
559 return t;
560 }
561 virtual std::vector<thrust::host_vector<real_type> > do_compute_map()const override final {
562 return a_;
563 }
564};
565
571
572}//namespace dg
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
base topology classes
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.