Examples
Linear problems
Filename |
Comments (preconditioners, numerical schemes) |
---|---|
Distributed LU/Cholesky, domain decomposition and multigrid methods |
|
Transient diffusion equation, same as above |
|
Periodic boundary conditions, multigrid methods |
|
Better load balancing than above example |
|
Balancing Domain Decomposition with Constraints |
|
Three-dimensional problem, domain decomposition and multigrid methods |
|
Geometric non-nested multigrid methods |
|
Geometric nested multigrid methods |
|
Domain decomposition methods with optimized boundary conditions |
|
Geometric multigrid methods |
|
Vectorial two-dimensional problem with a block preconditioner (fieldsplit) |
|
Vectorial three-dimensional problem with a block preconditioner (fieldsplit) |
|
Three-dimensional problem with h adaptivity, multigrid methods using Mmg |
|
Three-dimensional problem with fully-distributed h adaptivity using ParMmg |
|
Laplace equation with constraints and a block preconditioner (fieldsplit) |
|
Vectorial problem, domain decomposition (GenEO) and multigrid methods |
|
Domain decomposition (GenEO for saddle-point problems) |
|
Distributed LU/Cholesky |
|
Stokes equation defined as a block system with four matrices (fieldsplit) |
|
Block preconditioner (fieldsplit) |
|
Domain decomposition (GenEO for saddle-point problems) |
|
Oseen problem preconditioned by Pressure Convection–Diffusion (PCD) |
|
Direct LU/Cholesky |
|
Multigrid method |
|
Two-grid preconditioner |
|
BEM with hierarchical matrices from Htool on surfaces |
|
BEM with hierarchical matrices from Htool on lines |
|
FEM coupled with BEM in a MatNest using a block preconditioner (fieldsplit) |
|
Parallel interpolation on non-matching grids + P’ A P operation |
|
Coupled problems with one being defined on a restriction of the mesh of the other |
|
Bilaplacian using Morley finite element |
Nonlinear problems
Filename |
Comments (preconditioners, numerical schemes) |
---|---|
GenEO with reused coarse spaces |
|
Newton method and h adaptivity |
|
Newton method and a variational inequality |
|
Newton method, h adaptivity, and a variational inequality |
|
Linear elasiticty with a Newton method |
|
Nonlinear elasticity |
|
Steady-state Navier–Stokes equation for linear stability analysis |
|
Newton method and h adaptivity |
|
Variational inequalities |
Time steppers and optimizers
Filename |
Comments (preconditioners, numerical schemes) |
---|---|
Implicit and explicit schemes |
|
Minimal surface problem |
|
Eigenvalue problems
Filename |
Comments (preconditioners, numerical schemes) |
---|---|
Eigenvalue problem on a surface |
|
Eigenvalue problem on a curve |
|
Linear stability analysis of Navier–Stokes equations |
|
Inf-sup constant of Stokes equations |
|
SVD of the discretized Helmholtz equation |
|
Matrix-free SVD with user-provided matrix–vector and matrix transpose–vector multiplications |
|
Nonlinear eigenvalue problem Ax = sqrt(lambda)x |
|
Polynomial eigenvalue problem (A2 lambda^2 x + A1 lambda + A0)x = 0 |
Miscellaneous
Filename |
Comments (preconditioners, numerical schemes) |
---|---|
Solving a transposed system |
|
Computing an exact Schur complement |
|
Recursive mesh partitioning (for geometric multigrid) |
|
Connectivity construction with a user-supplied partitioning |
|
Creation of different partitions of unity using the same DD |
|
Saving and loading a distributed mesh for restarting a computation |
|
Parallel interpolation of finite element functions |
|
Construction of a distributed mesh from sequential nonoverlapping meshes |
|
Distributed ParMmg interface for mesh adaptation |
|
Gather and scatter a Dmesh on different MPI communicators |
|
Load and partition a mesh using a DM in two and three dimensions |
|
Custom plugin showing how to directly access PETSc in C++ |
|
Calling the convert FreeFEM function on a distributed mesh |
|
Loading a distributed matrix/vector with various formats |
Reproducible science
Article |
Source code |
---|---|
Augmented Lagrangian preconditioner for large-scale hydrodynamic stability analysis |
|
A multilevel Schwarz preconditioner based on a hierarchy of robust coarse spaces |
|