Discontinuous Galerkin Library
#include "dg/algorithm.h"
Loading...
Searching...
No Matches
fast_interpolation.h
Go to the documentation of this file.
1#pragma once
2
3#include <thrust/host_vector.h>
4#include "dg/backend/memory.h"
6#include "dg/enums.h"
7#include "dg/blas.h"
8#include "grid.h"
9#include "derivatives.h" // for update_left_right
10#include "interpolation.h"
11#include "projection.h"
12#ifdef MPI_VERSION
13#include "mpi_grid.h"
14#include "mpi_derivatives.h" // for make_mpi_sparseblockmat
15#endif //MPI_VERSION
16
17
22namespace dg
23{
24
35template <class MatrixType, class ContainerType>
37{
45 MultiMatrix( int dimension): m_inter(dimension), m_temp(dimension-1 > 0 ? dimension-1 : 0 ){}
46 template<class ...Params>
47 void construct( Params&& ...ps)
48 {
49 //construct and swap
50 *this = MultiMatrix( std::forward<Params>( ps)...);
51 }
52
53 //https://stackoverflow.com/questions/26147061/how-to-share-protected-members-between-c-template-classes
54 template< class OtherMatrix, class OtherContainer>
55 friend class MultiMatrix; // enable copy
56 template<class OtherMatrix, class OtherContainer, class ... Params>
58 {
59 unsigned dimsM = src.m_inter.size();
60 unsigned dimsT = src.m_temp.size();
61 m_inter.resize(dimsM);
62 m_temp.resize(dimsT);
63 for( unsigned i=0; i<dimsM; i++)
64 m_inter[i] = src.m_inter[i];
65 for( unsigned i=0; i<dimsT; i++)
66 dg::assign( src.m_temp[i], m_temp[i], std::forward<Params>(ps)...);
67 }
68 template<class ContainerType0, class ContainerType1>
69 void symv( const ContainerType0& x, ContainerType1& y) const{ symv( 1., x,0,y);}
70 template<class ContainerType0, class ContainerType1>
71 void symv(real_type alpha, const ContainerType0& x, real_type beta, ContainerType1& y) const
72 {
73 int dims = m_inter.size();
74 if( dims == 1)
75 {
76 dg::blas2::symv( alpha, m_inter[0], x, beta, y);
77 return;
78 }
79 dg::blas2::symv( m_inter[0], x,m_temp[0]);
80 for( int i=1; i<dims-1; i++)
81 dg::blas2::symv( m_inter[i], m_temp[i-1], m_temp[i]);
82 dg::blas2::symv( alpha, m_inter[dims-1], m_temp[dims-2], beta, y);
83 }
84 std::vector<ContainerType >& get_temp(){ return m_temp;}
85 const std::vector<ContainerType >& get_temp()const{ return m_temp;}
86 std::vector<MatrixType>& get_matrices(){ return m_inter;}
87 const std::vector<MatrixType>& get_matrices()const{ return m_inter;}
88 private:
89 std::vector<MatrixType > m_inter;
90 mutable std::vector<ContainerType > m_temp; // OMG mutable exits !? write even in const
91};
92
94template <class M, class V>
95struct TensorTraits<MultiMatrix<M, V> >
96{
98 using tensor_category = SelfMadeMatrixTag;
99};
100
101namespace detail
102{
103//pay attention that left and right must have correct sizes
104template<class real_type, class Topology>
105MultiMatrix< dg::HMatrix_t<real_type>, dg::HVec_t<real_type> > multiply( const dg::HMatrix_t<real_type>& left, const dg::HMatrix_t<real_type>& right, const Topology& t)
106{
107 MultiMatrix< dg::HMatrix_t<real_type>, dg::HVec_t<real_type> > matrix(2);
108 if( right.total_num_rows() != left.total_num_cols())
109 throw Error( Message(_ping_)<< "left and right cannot be multiplied due to wrong sizes" << left.total_num_cols() << " vs "<<right.total_num_rows());
110 matrix.get_matrices()[0] = right;
111 matrix.get_matrices()[1] = left;
112 thrust::host_vector<real_type> vec( right.total_num_rows());
113 matrix.get_temp()[0] = vec;
114 return matrix;
115}
116template<class real_type, size_t Nd>
117RealGrid<real_type, Nd> set_right_grid( const aRealTopology<real_type, Nd>& t, unsigned new_n , unsigned new_N)
118{
119 // We need to explicitly convert to grid
120 RealGrid<real_type,Nd> tnew (t);
121 tnew.set_axis( 0, new_n, new_N);
122 return tnew;
123}
124#ifdef MPI_VERSION
125template<class real_type, class MPITopology>
126MultiMatrix< dg::MHMatrix_t<real_type>, dg::MHVec_t<real_type> > multiply( const dg::MHMatrix_t<real_type>& left, const dg::MHMatrix_t<real_type>& right, const MPITopology& t)
127{
128 MultiMatrix< dg::MHMatrix_t<real_type>, dg::MHVec_t<real_type> > matrix(2);
129 if( right.inner_matrix().total_num_rows() != left.inner_matrix().total_num_cols())
130 throw Error( Message(_ping_)<< "left and right cannot be multiplied due to wrong sizes" << left.inner_matrix().total_num_cols() << " vs "<<right.inner_matrix().total_num_rows());
131 matrix.get_matrices()[0] = right;
132 matrix.get_matrices()[1] = left;
133 thrust::host_vector<real_type> vec( right.inner_matrix().total_num_rows());
134 matrix.get_temp()[0] = dg::MHVec_t<real_type>({vec, t.communicator()});
135
136 return matrix;
137}
138template<class real_type, size_t Nd>
139RealMPIGrid<real_type, Nd> set_right_grid( const aRealMPITopology<real_type, Nd>& t, unsigned new_n , unsigned new_N)
140{
141 // We need to explicitly convert to grid
142 RealMPIGrid<real_type,Nd> tnew (t);
143 tnew.set_axis( 0, new_n, new_N);
144 return tnew;
145}
146#endif
147} //namespace detail
148
150
151namespace create
152{
160
181template<class real_type>
182dg::HMatrix_t<real_type> fast_interpolation1d( const RealGrid1d<real_type>& t, unsigned multiplyn, unsigned multiplyNx)
183{
184 unsigned n=t.n();
185 dg::RealGrid1d<real_type> g_old( -1., 1., n, 1);
186 dg::RealGrid1d<real_type> g_new( -1., 1., n*multiplyn, multiplyNx);
187 // Does not generate explicit zeros ...
189 dg::create::interpolation( g_new, g_old);
190 unsigned size = multiplyn*multiplyNx;
191 EllSparseBlockMat<real_type, thrust::host_vector> iX( size*t.N(), t.N(), 1, size, t.n());
192 dg::blas1::copy( 0., iX.data);
193 for( unsigned row=0; row<interpolX.num_rows(); row++)
194 for( unsigned l=interpolX.row_offsets()[row]; l<(unsigned)interpolX.row_offsets()[row+1]; l++)
195 {
196 int col = interpolX.column_indices()[l];
197 real_type val = interpolX.values()[l];
198 iX.data[row*interpolX.num_cols() + col] = val;
199 }
200 for( unsigned i=0; i<size*t.N(); i++)
201 {
202 iX.cols_idx[i] = i/(size);
203 iX.data_idx[i] = i%(size);
204 }
205 return iX;
206}
207
227template<class real_type>
228dg::HMatrix_t<real_type> fast_projection1d( const RealGrid1d<real_type>& t, unsigned dividen, unsigned divideNx)
229{
230 if( t.N()%divideNx != 0)
231 throw Error( Message(_ping_)<< "Nx and divideNx don't match: Nx: "
232 << t.N()<< " divideNx "<< (unsigned)divideNx);
233 if( t.n()%dividen != 0)
234 throw Error( Message(_ping_)<< "n and dividen don't match: n: "
235 << t.n()<< " dividen "<< (unsigned)dividen);
236 unsigned n=t.n()/dividen;
237 dg::RealGrid1d<real_type> g_old( -1., 1., n*dividen, divideNx);
238 dg::RealGrid1d<real_type> g_new( -1., 1., n, 1);
239 // Does not generate explicit zeros ...
241 unsigned size = dividen*divideNx;
242 EllSparseBlockMat<real_type, thrust::host_vector> pX( t.N()/divideNx, t.N()*dividen, size, size, n);
243 dg::blas1::copy( 0., pX.data);
244 for( unsigned row=0; row<projectX.num_rows(); row++)
245 for( unsigned ll=projectX.row_offsets()[row]; ll<(unsigned)projectX.row_offsets()[row+1]; ll++)
246 {
247 int col = projectX.column_indices()[ll];
248 real_type val = projectX.values()[ll];
249 int k = col/(n*dividen), l = (col/n)%dividen, i = row, j = col%n;
250 pX.data[((k*dividen+l)*n+i)*n+j] = val;
251 }
252 for( unsigned i=0; i<t.N()/divideNx; i++)
253 for( unsigned d=0; d<size; d++)
254 {
255 pX.cols_idx[i*size+d] = i*size+d;
256 pX.data_idx[i*size+d] = d;
257 }
258 return pX;
259}
260
284template<class real_type>
286{
288 if( opx.size() != t.n())
289 throw Error( Message(_ping_)<< "SquareMatrix must have same n as grid!");
290 dg::assign( opx.data(), A.data);
291 for( unsigned i=0; i<t.N(); i++)
292 {
293 A.cols_idx[i] = i;
294 A.data_idx[i] = 0;
295 }
296 return A;
297}
298
301template<class real_type, size_t Nd>
303 const aRealTopology<real_type, Nd>& t, unsigned multiplyn, unsigned multiplyNx)
304{
305 auto trafo = dg::create::fast_interpolation1d( t.axis(coord),
306 multiplyn, multiplyNx);
307 detail::update_left_right( coord, trafo, t);
308 return trafo;
309}
310
313template<class real_type, size_t Nd>
315 const aRealTopology<real_type, Nd>& t, unsigned dividen, unsigned divideNx)
316{
317 auto trafo = dg::create::fast_projection1d( t.axis(coord),
318 dividen, divideNx);
319 detail::update_left_right( coord, trafo, t);
320 return trafo;
321}
322
325template<class real_type, size_t Nd>
328{
329 auto trafo = dg::create::fast_transform1d( opx, t.axis(coord));
330 detail::update_left_right( coord, trafo, t);
331 return trafo;
332}
333
334#ifdef MPI_VERSION
335
338template<class real_type, size_t Nd>
340 const aRealMPITopology<real_type, Nd>& t, unsigned multiplyn, unsigned multiplyNx)
341{
342 RealMPIGrid<real_type,1> t_rows = t.axis(coord);
343 t_rows.set( t.n(coord)*multiplyn, t.N(coord)*multiplyNx);
345 detail::local_global_grid(coord, t), multiplyn, multiplyNx),
346 t_rows, t.axis(coord));
347}
350template<class real_type, size_t Nd>
352 const aRealMPITopology<real_type, Nd>& t, unsigned dividen, unsigned divideNx)
353{
354 RealMPIGrid<real_type,1> t_rows = t.axis(coord);
355 t_rows.set( t.n(coord)/dividen, t.N(coord)/divideNx);
357 detail::local_global_grid(coord, t), dividen, divideNx),
358 t_rows, t.axis(coord));
359}
362template<class real_type, size_t Nd>
365{
367 detail::local_global_grid(coord, t)), t.axis(coord), t.axis(coord));
368}
369
370#endif //MPI_VERSION
371
372// Product interpolations/projections/transforms
373// TODO We may want to generalize this
374
379template<class Topology>
380auto fast_interpolation( const Topology& t, unsigned multiplyn, unsigned multiplyNx, unsigned multiplyNy)
381{
382 auto interX = dg::create::fast_interpolation( 0, t, multiplyn,multiplyNx);
383 auto tX = dg::detail::set_right_grid( t, t.n()*multiplyn, t.Nx()*multiplyNx);
384 auto interY = dg::create::fast_interpolation( 1, tX, multiplyn,multiplyNy);
385 return dg::detail::multiply( interY, interX, t);
386}
387
392template<class Topology>
393auto fast_projection( const Topology& t, unsigned dividen, unsigned divideNx, unsigned divideNy)
394{
395 auto interX = dg::create::fast_projection( 0, t, dividen, divideNx);
396 auto tX = dg::detail::set_right_grid( t, t.n()/dividen, t.Nx()/divideNx);
397 auto interY = dg::create::fast_projection( 1, tX, dividen, divideNy);
398 return dg::detail::multiply( interY, interX, t);
399}
403template<class Topology>
406 Topology& t)
407{
408 auto interX = dg::create::fast_transform( 0, opx, t);
409 auto interY = dg::create::fast_transform( 1, opy, t);
410 return dg::detail::multiply( interY, interX, t);
411}
413
414}//namespace create
415
428template<class Topology>
429typename Topology::host_vector forward_transform( const
430 typename Topology::host_vector& in, const Topology& g)
431{
432 typename Topology::host_vector out(in), tmp(in);
433 for( unsigned u=0; u<Topology::ndim(); u++)
434 {
436 Topology::value_type>::forward(g.n(u))}, g);
437 dg::blas2::symv( forward, out, tmp);
438 tmp.swap( out);
439 }
440 return out;
441}
442
443}//namespace dg
class intended for the use in throw statements
Definition exceptions.h:83
small class holding a stringstream
Definition exceptions.h:29
A square nxn matrix.
Definition operator.h:31
unsigned size() const
Size n of the SquareMatrix.
Definition operator.h:110
const std::vector< value_type > & data() const
access underlying data
Definition operator.h:127
Convenience functions to create 2D derivatives.
enums
#define _ping_
Definition exceptions.h:12
base topology classes
void copy(const ContainerTypeIn &source, ContainerTypeOut &target)
Definition blas1.h:243
void assign(const from_ContainerType &from, ContainerType &to, Params &&... ps)
Generic way to assign the contents of a from_ContainerType object to a ContainerType object optionall...
Definition blas1.h:767
void symv(MatrixType &&M, const ContainerType1 &x, ContainerType2 &y)
Definition blas2.h:325
@ forward
forward derivative (cell to the right and current cell)
Definition enums.h:98
@ y
y direction
@ x
x direction
typename TensorTraits< std::decay_t< Vector > >::value_type get_value_type
Definition tensor_traits.h:45
dg::HMatrix_t< real_type > fast_projection1d(const RealGrid1d< real_type > &t, unsigned dividen, unsigned divideNx)
Create projecton matrix for integer dividers.
Definition fast_interpolation.h:228
EllSparseBlockMat< real_type, thrust::host_vector > fast_transform(unsigned coord, const dg::SquareMatrix< real_type > &opx, const aRealTopology< real_type, Nd > &t)
Create a block-diagonal matrix.
Definition fast_interpolation.h:326
dg::HMatrix_t< real_type > fast_interpolation1d(const RealGrid1d< real_type > &t, unsigned multiplyn, unsigned multiplyNx)
Create interpolation matrix for integer multipliers.
Definition fast_interpolation.h:182
EllSparseBlockMat< real_type, thrust::host_vector > fast_interpolation(unsigned coord, const aRealTopology< real_type, Nd > &t, unsigned multiplyn, unsigned multiplyNx)
Create interpolation matrix for integer multipliers.
Definition fast_interpolation.h:302
dg::HMatrix_t< real_type > fast_transform1d(const dg::SquareMatrix< real_type > &opx, const RealGrid1d< real_type > &t)
Create a block-diagonal matrix.
Definition fast_interpolation.h:285
EllSparseBlockMat< real_type, thrust::host_vector > fast_projection(unsigned coord, const aRealTopology< real_type, Nd > &t, unsigned dividen, unsigned divideNx)
Create projecton matrix for integer dividers.
Definition fast_interpolation.h:314
Topology::host_vector forward_transform(const typename Topology::host_vector &in, const Topology &g)
Transform a vector from dg::xspace (nodal values) to dg::lspace (modal values)
Definition fast_interpolation.h:429
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
auto make_mpi_sparseblockmat(const EllSparseBlockMat< real_type, thrust::host_vector > &src, const ConversionPolicyRows &g_rows, const ConversionPolicyCols &g_cols)
Split given EllSparseBlockMat into computation and communication part.
Definition mpi_matrix.h:242
thrust::host_vector< T > HVec_t
Host Vector.
Definition typedefs.h:18
dg::MPI_Vector< dg::HVec_t< T > > MHVec_t
MPI Host Vector s.a. dg::HVec_t.
Definition typedefs.h:64
Interpolation matrix creation functions.
MPI Grid objects.
This is the namespace for all functions and classes defined and used by the discontinuous Galerkin li...
Creation of projection matrices.
Struct providing coefficients for Discrete Legendre Transformation (DLT) related operations.
Definition dlt.h:20
Ell Sparse Block Matrix format.
Definition sparseblockmat.h:46
Vector< real_type > data
The data array is of size n*n*num_different_blocks and contains the blocks. The first block is contai...
Definition sparseblockmat.h:168
Vector< int > data_idx
has the same size as cols_idx and contains indices into the data array, i.e. the block number
Definition sparseblockmat.h:170
int total_num_cols() const
total number of columns is num_cols*n*left_size*right_size
Definition sparseblockmat.h:99
Vector< int > cols_idx
is of size num_rows*num_blocks_per_line and contains the column indices % n into the vector
Definition sparseblockmat.h:169
int total_num_rows() const
total number of rows is num_rows*n*left_size*right_size
Definition sparseblockmat.h:95
A simple wrapper around a container object and an MPI_Comm.
Definition mpi_vector.h:37
Distributed memory Sparse block matrix class, asynchronous communication.
Definition mpi_matrix.h:143
const LocalMatrixInner & inner_matrix() const
Read access to the inner matrix.
Definition mpi_matrix.h:161
Struct that applies given matrices one after the other.
Definition fast_interpolation.h:37
MultiMatrix(const MultiMatrix< OtherMatrix, OtherContainer > &src, Params &&... ps)
Definition fast_interpolation.h:57
void symv(real_type alpha, const ContainerType0 &x, real_type beta, ContainerType1 &y) const
Definition fast_interpolation.h:71
std::vector< ContainerType > & get_temp()
Definition fast_interpolation.h:84
const std::vector< ContainerType > & get_temp() const
Definition fast_interpolation.h:85
friend class MultiMatrix
Definition fast_interpolation.h:55
void construct(Params &&...ps)
Definition fast_interpolation.h:47
std::vector< MatrixType > & get_matrices()
Definition fast_interpolation.h:86
get_value_type< ContainerType > real_type
Definition fast_interpolation.h:38
const std::vector< MatrixType > & get_matrices() const
Definition fast_interpolation.h:87
void symv(const ContainerType0 &x, ContainerType1 &y) const
Definition fast_interpolation.h:69
MultiMatrix()
Definition fast_interpolation.h:39
MultiMatrix(int dimension)
reserve space for dimension matrices and dimension-1 ContainerTypes
Definition fast_interpolation.h:45
The simplest implementation of aRealTopology.
Definition grid.h:710
The simplest implementation of aRealMPITopology3d.
Definition mpi_grid.h:783
A CSR formatted sparse matrix.
Definition sparsematrix.h:96
size_t num_cols() const
Number of columns in matrix.
Definition sparsematrix.h:276
const Vector< Index > & row_offsets() const
Read row_offsets vector.
Definition sparsematrix.h:287
const Vector< Index > & column_indices() const
Read column indices vector.
Definition sparsematrix.h:291
const Vector< Value > & values() const
Read values vector.
Definition sparsematrix.h:295
size_t num_rows() const
Number of rows in matrix.
Definition sparsematrix.h:274
NotATensorTag tensor_category
Definition tensor_traits.h:40
void value_type
Definition tensor_traits.h:39
An abstract base class for MPI distributed Nd-dimensional dG grids.
Definition mpi_grid.h:91
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
unsigned N(unsigned u=0) const
Get number of cells for axis u.
Definition mpi_grid.h:230
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
An abstract base class for Nd-dimensional dG grids.
Definition grid.h:95
unsigned n(unsigned u=0) const
Get number of polynomial coefficients for axis u.
Definition grid.h:262
RealGrid< real_type, 1 > axis(unsigned u) const
An alias for "grid".
Definition grid.h:282
unsigned N(unsigned u=0) const
Get number of cells for axis u.
Definition grid.h:265
Useful typedefs of commonly used types.