All Projects → ABAtanasov → GalerkinSparseGrids.jl

ABAtanasov / GalerkinSparseGrids.jl

Licence: other
Sparse Grid Discretization with the Discontinuous Galerkin Method for solving PDEs

Programming Languages

julia
2034 projects

Projects that are alternatives of or similar to GalerkinSparseGrids.jl

SGpp
SG⁺⁺ – the numerical library for Sparse Grids in all their variants.
Stars: ✭ 59 (+51.28%)
Mutual labels:  interpolation, pde, sparse-grids
jaxdf
A JAX-based research framework for writing differentiable numerical simulators with arbitrary discretizations
Stars: ✭ 50 (+28.21%)
Mutual labels:  pde, discretization
MAESTRO
A low Mach number stellar hydrodynamics code
Stars: ✭ 29 (-25.64%)
Mutual labels:  astrophysics, pde
Transformr
Smooth Polygon Transformations
Stars: ✭ 87 (+123.08%)
Mutual labels:  interpolation
Cyclicgen
Deep Video Frame Interpolation using Cyclic Frame Generation
Stars: ✭ 135 (+246.15%)
Mutual labels:  interpolation
Peroxide
Rust numeric library with R, MATLAB & Python syntax
Stars: ✭ 191 (+389.74%)
Mutual labels:  interpolation
naima
Derivation of non-thermal particle distributions through MCMC spectral fitting
Stars: ✭ 32 (-17.95%)
Mutual labels:  astrophysics
Super Slowmo
An attempt at a PyTorch implimentation of "Super SloMo: High Quality Estimation of Multiple Intermediate Frames for Video Interpolation"
Stars: ✭ 73 (+87.18%)
Mutual labels:  interpolation
Geostats.jl
An extensible framework for high-performance geostatistics in Julia
Stars: ✭ 222 (+469.23%)
Mutual labels:  interpolation
Mathtoolbox
Mathematical tools (interpolation, dimensionality reduction, optimization, etc.) written in C++11 with Eigen
Stars: ✭ 172 (+341.03%)
Mutual labels:  interpolation
Unity Fastpacedmultiplayer
Features a Networking Framework to be used on top of Unity Networking, in order to implement an Authoritative Server with Lag Compensation, Client-Side Prediction/Server Reconciliation and Entity Interpolation
Stars: ✭ 162 (+315.38%)
Mutual labels:  interpolation
Spade
Spatial Data Structures for Rust
Stars: ✭ 135 (+246.15%)
Mutual labels:  interpolation
Xesmf
Universal Regridder for Geospatial Data
Stars: ✭ 197 (+405.13%)
Mutual labels:  interpolation
Gonum
开源Go语言数值算法库(An open numerical library purely based on Go programming language)
Stars: ✭ 128 (+228.21%)
Mutual labels:  interpolation
Pupa
Simple micro templating
Stars: ✭ 231 (+492.31%)
Mutual labels:  interpolation
Pytoflow
The py version of toflow → https://github.com/anchen1011/toflow
Stars: ✭ 83 (+112.82%)
Mutual labels:  interpolation
Mathnet Numerics
Math.NET Numerics
Stars: ✭ 2,688 (+6792.31%)
Mutual labels:  interpolation
Mixtext
MixText: Linguistically-Informed Interpolation of Hidden Space for Semi-Supervised Text Classification
Stars: ✭ 159 (+307.69%)
Mutual labels:  interpolation
Interpolate
Swift interpolation for gesture-driven animations
Stars: ✭ 1,809 (+4538.46%)
Mutual labels:  interpolation
3d Bat
3D Bounding Box Annotation Tool (3D-BAT) Point cloud and Image Labeling
Stars: ✭ 179 (+358.97%)
Mutual labels:  interpolation

A Module for Sparse Grid Discretization using Discontinuous Galerkin Bases

Build Status codecov

This Julia language package is intended for accurately and efficiently solving hyperbolic partial differential equations in higher dimensions, where the curse of dimensionality restricts the computational feasibility of discretization of space using regular grid methods. Instead, we employ the sparse grid construction as in Bungartz & Griebel.

The ambitious long-term goal of this package is the efficient and accurate numerical solution of Einstein's equations in full 3+1 dimensional space under conditions of very low to no symmetry. Such simulations would be a great step forward in many diverse areas of strong gravity, including the modeling of dark matter, dark energy, and gravitational wave cosmology. We are not there yet, but we have already made progress in the simpler cases of transport and wave equation evolution and high-dimensional interpolation of initial conditions.

In order to make full anisotropic gravitational evolution a reality, several necessary additions are in the progress of being implemented:

  • Handling a wider class of boundary value problems, accounting for decay conditions at infinity
  • Handling one or more singularity points (e.g. for interacting black holes)
  • Easy and general way to handle coordinate patching of the spacetime

For more information, see Sparse Grid Discretizations based on a Discontinuous Galerkin Method

The sparse grid methods of this package apply well beyond numerical relativity to many areas in high-dimensional dynamics and data science. The user is invited to experiment.

Authors: Alex Atanasov ([email protected]) & Erik Schnetter ([email protected])

Installing

Prerequisites for using this package are:

Julia-1.0 (Latest Release)
ODE.jl	(For running the timesteps to solve the sparse dynamical evolution)
Cubature.jl (working to remove this prerequisite)
StaticArrays (new, trying this out - could produce large speedup)

They can be added using the Julia package manager. Source documentation is here for ODE.jl and here for Cubature.jl.

Within Julia, use the package manager to write Pkg.clone("git://github.com/ABAtanasov/GalerkinSparseGrids.jl") to locally install this package.

The latest version is available to be pulled from http://github.com/ABAtanasov/GalerkinSparseGrids.jl. You can access it by running git pull https://github.com/ABAtanasov/GalerkinSparseGrids.jl master from the appropriate package directory.

Functionality

This package allows for the efficient interpolation, differentiation, and time evolution of high-dimensional datasets.

Summary of the DG Basis

In the 1-dimensional setting, the standard DG basis at order k and resolution n is equivalent to subdividing the axis in to 2^n sub-intervals and interpolating the function by polynomials of order strictly less than k on each of these sub-intervals. This gives a vector space of size k 2^n.

To make this compatible with sparse grids in higher dimensions, we find a "multi-resolution" basis for this vector space. That is, our basis functions v(level, cell, mode) are indexed by a level ranging from 0 to n and then a cell ranging from 0 to 2^l - 1 so that v is supported on (p 2^(-l), (p+1) 2^(-l)). Lastly, mode ranges over the k polynomials on each such interval. These v are made orthonormal to one another by a Grahm-Schmidt process detailed in Alpert and implemented in DG_Basis.jl

In D-dimensions, we use the standard tensor-products construction on these 1-D basis functions to obtain a basis of size (k 2^n)^D. For a default full grid, this vector space is equivalent to subdividing each axis of this domain into 2^n sub-intervals, for a total of 2^(n D) hypercubes, and interpolating the function on each of these subdomains by multivariate polynomials of degree strictly less than k. The basis functions V(level, cell, mode) now have each of their arguments as a D-vector.

Because this scheme becomes rapidly and prohibitively expensive in high dimensions, we apply the well-known sparse grid cutoff to exclude all basis functions with levels having 1-norm greater than n. This reduces us from O(k^D 2^(n D)) to O(k^D 2^n n^(D-1)).

Interpolation

The following method interpolates a given function f on the D-dimensional hypercube [0,1]^D.

coeffs_DG(D::Int, k::Int, n::Int, f::Function; scheme="sparse")

For example, to interpolate a 2-D function at order k = 3 and n = 5, we would do

D = 2; k = 3; n = 5;
f = x->sin(2*pi*x[1])*sin(2*pi*x[2])
full_coeffs   = coeffs_DG(D, k, n, f; scheme="full"  )
sparse_coeffs = coeffs_DG(D, k, n, f; scheme="sparse")

This gives a dictionary indexed by multi-levels of type CartesianIndex{2}. For a given multi-level, any dictionary entry is an array of arrays indexed by the multi-cell and multi-mode that holds the coefficient data.

In either case, the interpolation can be evaluated at a given point xs (given by an array of length D) by

full_val   = reconstruct_DG(full_coeffs  , xs)
sparse_val = reconstruct_DG(sparse_coeffs, xs)

No scheme, D, k, or n, need be specified, as all of these can be deduced from the dictionary itself.

The default scheme is always "sparse".

Solving Hyperbolic PDEs

All solvers can be found in the PDEs.jl script. The simplest one solves the wave equation in 1-D using the DG position basis

wave_evolve_1D(k::Int, n::Int,
			   f0::Function, v0::Function,
			   time0::Real, time1::Real;
			   base = "hier", order = "45").

Here, k and n are as before, f0 is the initial condition for position, v0 is the initial condition for velocity, time0 and time1 are the initial and final times of evolution. For 1D, we can also use the "pos" position basis (rather than the multi-resolution), and order "78" ode solvers. In either case, ode45/ode78 from ODE.jl are respectively used to solve the differential equation.

For example, for a standing wave solution from t_0 to t_1 seconds with k polynomials on each division, up to hierarchical level n, using ode78:

f0 = x->sin(2*pi*x[1])
v0 = x->0
hier_soln = wave_evolve_1D(k, n, f0, v0, t_0, t_1; order="78")

For higher dimensions, we use

wave_evolve(D::Int, k::Int, n::Int,
			f0::Function, v0::Function,
			time0::Real, time1::Real;
			order="45", scheme="sparse")

For example, to solve a standing wave in 2-D from t_0 to t_1 with polynomials of degree less than k on each division, sparse depth n, and using ode78:

f0 = x->sin(2*pi*x[1])*sin(2*pi*x[2])
v0 = 0
sparse_soln = wave_evolve(2, k, n, f0, v0, t_0, t_1; order="78")

At n = 1, this is the same as wave_evolve_1D in the "hier" basis.

Although the option scheme = "full" is implemented for higher dimensions, it is almost never computationally feasible, even in dimensions as low as D = 3.

Coefficient Vectors

It is best to work directly with vectors of coefficients rather than dictionary or tree-like structures when defining linear operators (like differentiation) acting on the interpolations. This way, derivatives are represented by sparse matrices that can act on the coefficient vectors with very fast performance. This is ideal for time evolution.

For this reason we have the vcoeffs_DG method that works exactly the same as their non-vector relatives, but return a coefficient vector instead of a dictionary.

We can convert between coefficient vectors and corresponding dictionaries as follows (in 2D with k = 3, n = 5):

D = 2; k = 3; n = 5;
f = x->sin(4*x[1]+x[2])

full_vcoeffs = vcoeffs_DG(D, k, n, f; scheme="full")
full_dict = V2D(D, k, n, full_vcoeffs; scheme="full")

Note this also means full_vcoeffs = D2V(D, k, n, full_dict; scheme="full")

sparse_vcoeffs = vcoeffs_DG(D, k, n, f; scheme="sparse")
sparse_dict = V2D(D, k, n, sparse_vcoeffs; scheme="sparse")

Note this also means sparse_vcoeffs = D2V(D, k, n, sparse_dict; scheme="sparse")

In addition, we can generate a lookup by using the D2Vref and V2Drefthat takes us from a dictionary-like level-cell-mode scheme to a specific index in a coefficient vector and vice versa. This is useful when trying to understand specific values in a vector of coefficients.

If we have the vector sparse_vcoeffs as above and wanted to understand what (level, cell, mode) corresponds to the value of sparse_vcoeffs[10], the code would be

VD = V2Dref(D, k, n; scheme="sparse")
VD[10]

Conversely, If we wanted to see what index we should look at to get the coefficient for (level, cell, mode) = ((4,4), (1,2), (2, 3)), the code would be

level	= CartesianIndex{2}((4, 4))
cell	= CartesianIndex{2}((1, 2))
mode	= CartesianIndex{2}((2, 3))
DV  	= D2Vref(D, k, n; scheme="sparse")
index	= DV[(level, cell, mode)]

Differentiation

The higher dimensional full and sparse derivative operators are implemented in Multidim_Derivative.jl. Here, D, k, and n are as before, and i specifies the axis along which the derivative is taken.

D_matrix(D::Int, i::Int, k::Int, n::Int; scheme="sparse")

We also have the gradient vector that is D_matrix over all i, and the Laplacian:

grad_matrix(D::Int, k::Int, n::Int; scheme="sparse")
laplacian_matrix(D::Int, k::Int, n::Int; scheme="sparse")

All these matrices act directly on the coefficient vectors obtained from vcoeffs_DG. For now, we assume periodic boundary conditions. It is not too difficult to generalize away from a periodic boundary.

In the discontinuous Galerkin method, it is customary to formulate the derivative in the weak sense, and that is how this method is implemented. As is standard, the derivative matrix elements are calculated through an integration by parts, leading to the derivative matrix having two summands: one being a boundary term and the other a derivative term on the interior.

Construction of the DG Basis

The DG position basis in consists of k Legendre polynomials (from degree 0 to k-1) supported on subintervals of the form (i 2^-level, (i+1) 2^-level). By construction, this gives an orthonormal basis. For this standard 1-D DG basis, the method get_vcoeffs(k::Int, level::Int, f::Function) gives an appropriate array of coefficients that can be reconstructed at a point x using reconstruct_vcoeffs(k,level,coefficients,x).

The corresponding multiresolution basis formed by a series of orthogonalizations implemented in DG_Functions.jl. This basis spans the same space as the position basis, but makes use of a discontinuous basis (c.f. 1D_DG_Functions.jl) to achieve the hierarchical structure.

(More to come on orthogonalization schemes)

Future updates

The family of PDEs that can be solved is currently being extended to include a wide variety of Einstein-like equations. The set of boundary conditions is currently being expanded beyond just periodic and Dirichlet conditions, to account for vanishing conditions at conformal infinity, as well as to handle singularities.

Future updates include adaptivity as well as parallelizability to these methods.

References

A Sparse Grid Discontinuous Galerkin Method for high-dimensional transport equations

Sparse Grid DG Methods for Elliptic Equations

Gerstner & Griebel: A survey of sparse grid discretization and applciations to quadrature, data compression, and dynamical systems

Introduction to the Interior Penality Discontinuous Galerkin (IPDG)

Note that the project description data, including the texts, logos, images, and/or trademarks, for each open source project belongs to its rightful owner. If you wish to add or remove any projects, please contact us at [email protected].