Discontinuous Galerkin Library
#include "dg/algorithm.h"
Loading...
Searching...
No Matches
projection.h
Go to the documentation of this file.
1#pragma once
2#include <vector>
3#include "grid.h"
4#include "interpolation.h"
5#include "weights.h"
6#include "fem.h"
7
12namespace dg{
13
23template<class T>
24T gcd( T a, T b)
25{
26 T r2 = std::max(a,b);
27 T r1 = std::min(a,b);
28 while( r1!=0)
29 {
30 r2 = r2%r1;
31 std::swap( r1, r2);
32 }
33 return r2;
34}
35
45template<class T>
46T lcm( T a, T b)
47{
48 T g = gcd( a,b);
49 return a/g*b;
50}
51
52namespace create{
55
63template<class real_type>
65{
66 unsigned size = diagonal.size();
67 thrust::host_vector<int> A_row_offsets(size+1), A_column_indices( size);
68 thrust::host_vector<real_type> A_values( size);
69
70 A_row_offsets[0] = 0;
71 for( unsigned i=0; i<size; i++)
72 {
73 A_row_offsets[i+1] = i+1;
74 A_column_indices[i] = i;
75 A_values[i] = diagonal[i];
76 }
77 return { size, size, A_row_offsets, A_column_indices, A_values};
78}
79
80
107template<class real_type, size_t Nd>
109 const aRealTopology<real_type,Nd>& g_new,
110 const aRealTopology<real_type,Nd>& g_old, std::string method = "dg")
111{
112 // These tests cannot pass for MPI
113 //for( unsigned u=0; u<Nd; u++)
114 //{
115 // if( fabs(g_new.h(u) / g_old.h(u) -round(g_new.h(u) / g_old.h(u))) > 1e-13)
116 // throw dg::Error( dg::Message(_ping_)
117 // << "# ATTENTION: you project between incompatible grids!! old h: "
118 // <<g_old.h(u)<<" new h: "<<g_new.h(u)<<"\n");
119 // // Check that boundaries of old grid conincide with cell boundaries of new
120 // real_type fp = (g_old.p(u) - g_new.p(u) ) / g_new.h(u); // must be integer
121 // if( fabs(fp - round( fp)) > 1e-13 and method == "dg")
122 // throw dg::Error( dg::Message(_ping_)
123 // << "# ATTENTION: you project between incompatible grids!! old p: "
124 // <<g_old.p(u)<<" new p: "<<g_new.p(u)<<" fp "<<fp<<"\n");
125 // real_type fq = (g_old.q(u) - g_new.p(u) ) / g_new.h(u); // must be integer
126 // if( fabs(fq - round( fq)) > 1e-13 and method == "dg")
127 // throw dg::Error( dg::Message(_ping_)
128 // << "# ATTENTION: you project between incompatible grids!! old q: "
129 // <<g_old.q(u)<<" new p: "<<g_new.p(u)<<" fq "<<fq<<"\n");
130 // if( g_old.n(u) < g_new.n(u))
131 // throw dg::Error( dg::Message(_ping_)
132 // << "# ATTENTION: you project between incompatible grids!! old n: "
133 // <<g_old.n(u)<<" new n: "<<g_new.n(u)<<"\n");
134 //}
135 //form the adjoint
136 auto w_old = dg::create::weights( g_old);
137 auto v_new = dg::create::inv_weights( g_new);
138 auto project = interpolation( g_old, g_new, method).transpose();
139 for( unsigned row=0; row<project.num_rows(); row++)
140 for ( int jj = project.row_offsets()[row]; jj < project.row_offsets()[row+1]; jj++)
141 {
142 int col = project.column_indices()[jj];
143 // Note that w_old is multiplied before v_new (keeps results backwards reproducible)
144 project.values()[jj] = v_new[row] * ( project.values()[jj]* w_old[col]);
145 }
146 return project;
147}
148
171template<class real_type, size_t Nd>
173 const aRealTopology<real_type,Nd>& g_new,
174 const aRealTopology<real_type,Nd>& g_old)
175{
176 std::array<unsigned, Nd> n_lcm, N_lcm;
177 for( unsigned u=0; u<Nd; u++)
178 {
179 n_lcm [u] = lcm( g_new.n(u), g_old.n(u));
180 N_lcm [u] = lcm( g_new.N(u), g_old.N(u));
181 }
182 RealGrid<real_type, Nd> g_lcm ( g_new.get_p(), g_new.get_q(), n_lcm, N_lcm, g_new.get_bc());
183 return create::projection( g_new, g_lcm)*create::interpolation( g_lcm, g_old);
184}
185
189
199template<class real_type, size_t Nd>
201{
202 std::array<dg::IHMatrix_t<real_type>,Nd> matrix;
203 for( unsigned u=0; u<Nd; u++)
204 {
205 unsigned n=g.n(u);
206 dg::RealGrid1d<real_type> g_old( -1., 1., n, 1);
207 dg::RealGrid1d<real_type> g_new( -1., 1., 1, n);
208 auto block = dg::create::transformation( g_new, g_old);
210 for( unsigned i=0; i<block.num_rows(); i++)
211 for( unsigned j=block.row_offsets()[i]; j<(unsigned)block.row_offsets()[i+1]; j++)
212 op( i, block.column_indices()[j]) = block.values()[j];
213 matrix[u] = (dg::IHMatrix_t<real_type>)dg::tensorproduct( g.N(u), op);
214
215 }
216 for( unsigned u=1; u<Nd; u++)
217 matrix[0] = dg::tensorproduct( matrix[u], matrix[0]);
218 return matrix[0];
219}
220
231template<class real_type, size_t Nd>
233{
234 std::array<dg::IHMatrix_t<real_type>,Nd> matrix;
235 for( unsigned u=0; u<Nd; u++)
236 {
237 unsigned n=g.n(u);
238 dg::RealGrid1d<real_type> g_old( -1., 1., n, 1);
239 dg::RealGrid1d<real_type> g_new( -1., 1., 1, n);
240 auto block = dg::create::transformation( g_new, g_old);
242 for( unsigned i=0; i<block.num_rows(); i++)
243 for( unsigned j=block.row_offsets()[i]; j<(unsigned)block.row_offsets()[i+1]; j++)
244 op( i, block.column_indices()[j]) = block.values()[j];
246
247 }
248 for( unsigned u=1; u<Nd; u++)
249 matrix[0] = dg::tensorproduct( matrix[u], matrix[0]);
250 return matrix[0];
251}
252
254
255}//namespace create
256}//namespace dg
A square nxn matrix.
Definition operator.h:31
base topology classes
T gcd(T a, T b)
Greatest common divisor.
Definition projection.h:24
T lcm(T a, T b)
Least common multiple.
Definition projection.h:46
auto inv_weights(const Topology &g)
Inverse nodal weight coefficients.
Definition weights.h:107
auto weights(const Topology &g)
Nodal weight coefficients.
Definition weights.h:62
dg::MIHMatrix_t< typename MPITopology::value_type > projection(const MPITopology &g_new, const MPITopology &g_old, std::string method="dg")
Create a projection between two grids.
Definition mpi_projection.h:272
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")
Create interpolation matrix of a list of points in given grid.
Definition interpolation.h:433
dg::SparseMatrix< int, real_type, thrust::host_vector > diagonal(const thrust::host_vector< real_type > &diagonal)
Create a diagonal matrix.
Definition projection.h:64
dg::SparseMatrix< int, real_type, thrust::host_vector > transformation(const aRealTopology< real_type, Nd > &g_new, const aRealTopology< real_type, Nd > &g_old)
Create a transformation matrix between two grids.
Definition projection.h:172
dg::SquareMatrix< T > invert(const dg::SquareMatrix< T > &in)
Compute inverse of square matrix (alias for dg::create::inverse)
Definition operator.h:691
SquareMatrix< T > tensorproduct(const SquareMatrix< T > &op1, const SquareMatrix< T > &op2)
Form the tensor product between two operators.
Definition operator_tensor.h:25
dg::IHMatrix_t< real_type > inv_backproject(const aRealTopology< real_type, Nd > &g)
Create a matrix that transforms values from an equidistant grid back to a dg grid.
Definition projection.h:232
dg::IHMatrix_t< real_type > backproject(const aRealTopology< real_type, Nd > &g)
Create a matrix that projects values to an equidistant grid.
Definition projection.h:200
Interpolation matrix creation functions.
This is the namespace for all functions and classes defined and used by the discontinuous Galerkin li...
The simplest implementation of aRealTopology.
Definition grid.h:710
A CSR formatted sparse matrix.
Definition sparsematrix.h:96
An abstract base class for Nd-dimensional dG grids.
Definition grid.h:95
std::array< real_type, Nd > get_q() const
Get right boundary point .
Definition grid.h:207
std::array< dg::bc, Nd > get_bc() const
Get boundary condition for all axes.
Definition grid.h:240
unsigned n(unsigned u=0) const
Get number of polynomial coefficients for axis u.
Definition grid.h:262
std::array< real_type, Nd > get_p() const
Get left boundary point .
Definition grid.h:202
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.