DEALII
A Finite Element Differential Equations Analysis Library


DEALII: examples which illustrate the use of DEAL.II, a C++ program library for the computational solution of partial differential equations using adaptive finite elements.

DEAL.II comes with an extensive set of examples, whose names are step-1, step-2, and so on. Those examples present features of the program.

DEAL.II can read meshes created by the user, in various formats, including:

The examples presented here focus on using DEAL.II on a local installation, and, in some cases, using DEAL.II for applications of specific interest to our own users.

Warning: in general, you can't take an example code such as step-5.cc, that is from the OSX distribution, and run it on a Linux system. There are often small but deadly differences in the source codes of the same example, issued for different systems.

The DEAL.II package is available from http://www.dealii.org/ .

Licensing:

The computer code and data files made available on this web page are distributed under the GNU LGPL license.

Related Data and Programs:

DEALII_OSX, examples which illustrate the use of DEAL.II on a Macintosh running the OSX operating system, a finite element method (FEM) Differential Equations Analysis Library (DEAL), for the definition and solution of partial differential equations (PDE's), by Wolfgang Bangerth and others.

DEALII_RCC, examples which illustrate the use of DEAL.II, a finite element method (FEM) Differential Equations Analysis Library (DEAL), for the definition and solution of partial differential equations (PDE's), by Wolfgang Bangerth and others, on the FSU Research Computing Center (RCC) cluster.

FENICS, programs which illustrate the use of a collection of free software with an extensive list of features for automated, efficient solution of differential equations.

FREEFEM++, a directory of examples which illustrate the use of the FREEFEM++ package, a high-level integrated development environment for the numerical solution of nonlinear multiphysics partial differential equations in 2D and 3D.

GNUPLOT, examples which illustrate the use of the gnuplot graphics program.

GPL_DISPLAY, a MATLAB library which tries to read the data in a typical gnuplot GPL file, describing a 1D, 2D or 3D curve, or a surface Z(X,Y) defined on a regular grid, a triangular grid, or an irregular quadrilateral grid, displays it in a more attractive way than gnuplot is capable of.

IFISS, examples which illustrate the use of IFISS, the MATLAB-based flow-solver.

MITCHELL_DEALII, examples which illustrate the implementation of the Mitchell 2D elliptic partial differential equation (PDE) test problems using DEAL.II.

PARAVIEW, examples which illustrate the use of PARAVIEW, a visualization program.

TETHEX, examples which illustrate the use of TETHEX, a C++ program which can read a Gmsh file defining a mesh of triangles or tetrahedrons, and subdivide the mesh into quadrilaterals or hexahedrons, which are suitable for use by the DEALII finite element program, by Mikhail Artemiev.

UCD, a data directory which contains examples of Unstructured Cell Data (UCD), a format supported by AVS.

VISIT, examples which illustrate the use of VISIT, a visualization program.

Reference:

  1. Wolfgang Bangerth, Ralf Hartmann, Guido Kanschat,
    DEAL.II - a general-purpose object-oriented finite element library,
    ACM Transactions on Mathematical Software,
    Volume 33, Number 4, article 24, August 2007.

Examples and Tests:

step-1, is the first example from the official DEAL.II example directory.

step-2, assigns degrees of freedom to the nodes of a grid, determines the sparsity pattern of the corresponding matrix, and then reorders the variables to get a tighter bandwidth.

step-2mod, a variation of step-2 which queries and prints the number of nonzeros, and the bandwidth before and after renumbering, for piecewise linear, quadratic, or cubic basis functions.

step-3, is the third example from the official DEAL.II example directory. It generates a graphics file which displays the structure of the solution.

step-4, is example 4 from the official DEAL.II example directory. It solves the Laplace equation in 2D and in 3D.

step-5, is example 5 from the official DEAL.II example directory. It reads grid information from a file.

step-6, is from the official DEAL.II example directory. It generates a sequence of locally refined grids.

step-7, is from the official DEAL.II example directory. It generates TeX files of convergence tables, and shows how to specify nonhomogenous Neumann boundary conditions for the Helmholtz equation.

step-8, is from the official DEAL.II example directory. It sets up and solves the elasticity equations.

You can go up one level to the EXAMPLES directory.


Last revised on 19 July 2016.