--- /dev/null
+The newly released Version 3.1 of deal.II, an object-oriented finite
+element library, is available from the deal.II home-page at
+
+ http://gaia.iwr.uni-heidelberg.de/~deal
+
+It has significant improvements over the old version 3.0. See the news
+page at
+ http://gaia.iwr.uni-heidelberg.de/~deal/news/2000/3.0.0-vs-3.1.0.html
+
+deal.II is a C++ class library targeted at adaptive finite elements.
+It uses state-of-the-art programming techniques of the C++ programming
+language to offer you a modern interface to the complex data
+structures and algorithms required for locally refined meshes and
+enables you to use a variety of finite elements in one, two, and three
+space dimensions, as well as support for time-dependent problems.
+
+The library is written for research purposes and offers many features:
+- Support for one, two, and three space dimensions, using a unified
+ interface that enables writing programs almost dimension independent.
+
+- Handling of locally refined grids, including different adaptive
+ refinement strategies based on local error indicators and error
+ estimators.
+
+- Support for a variety of finite elements, including Lagrange
+ elements of order one through four, and discontinuous elements.
+
+- Extensive documentation: all documentation is available online in a
+ logical tree structure to allow fast access to the information you
+ need. If printed it comprises about 250 pages of tutorials, several
+ reports, and far more than 1,000 pages of programming interface
+ documentation with explanations of all classes, functions, and
+ variables.
+
+- Modern software techniques that make access to the complex data
+ structures and algorithms as transparent as possible. The use of
+ object oriented programming allows for program structures similar to
+ the structures in mathematical analysis.
+
+- Fast algorithms that enable you to solve problems with up to several
+ millions of degrees of freedom quickly. As opposed to programming
+ symbolic algebra packages the penalty for readability is low.
+
+- Support for several output formats, including some common formats
+ for visualization of scientific data.
+
+- Support for a variety of computer platforms, including multi-
+ processor machines.
+
+- Free source code under an Open Source license for noncommercial
+ purposes, and the invitation to contribute to further development of
+ the library.
+
+
+Wolfgang Bangerth, Ralf Hartmann, Guido Kanschat, the deal.II team
--- /dev/null
+Version 3.2 of the well-known deal.II object-oriented finite element
+library has been released. It is available from the deal.II home-page
+at
+ http://gaia.iwr.uni-heidelberg.de/~deal
+
+The most important improvements are:
+- Mapping of arbitrary order at curved boundaries. This includes the
+ possibility of using sub-, iso-, and super-parametric elements, as
+ well as C1 mappings and shape functions depending on the actual grid
+ cell.
+- A matrix class for conveniently filtering Dirichlet boundary values
+ without modifying the system matrix.
+- A wide variety of target systems by ISO C++ conformance.
+Beside these, the list of changes comprises more than 100 new
+functions, classes, and bug fixes. A concise list with respect to the
+previous version can be found at
+ http://gaia.iwr.uni-heidelberg.de/~deal/news/2001/3.1.0-vs-3.2.0.html
+
+All main features of the previous versions have been continued and
+improved:
+- Support for dimension-independent programming
+- Extensive documentation and working example programs
+- Locally refined grids
+- Continuous and discontinuous elements of higher order
+- Fast linear algebra
+- Built-in support for symmetric multi-processing (SMP)
+- Output for a variety of visualization platforms
+
+deal.II is distributed under an Open Source license and is free for
+non-commercial use.
+
+
+Wolfgang Bangerth, Ralf Hartmann, Guido Kanschat, the deal.II team
--- /dev/null
+Version 3.3 of the deal.II object-oriented finite element library has
+been released. It is available from the deal.II home-page at
+
+ http://gaia.iwr.uni-heidelberg.de/~deal
+
+The most important improvements compared to the previous version are:
+- Support for the graphical file formats used by Tecplot and OpenDX.
+- An example program demonstrating the Discontinuous Galerkin Finite
+ Element Method (DGFEM).
+- Support for subdomains, thus simplifying the creation of programs
+ that run on clusters of computers.
+
+Beside these, the list of changes comprises more than 50 new
+functions, classes, and bug fixes. A concise list with respect to the
+previous version can be found at
+ http://gaia.iwr.uni-heidelberg.de/~deal/news/2002/3.2.0-vs-3.3.0.html
+
+All main features of the previous versions have been continued and
+improved:
+- Support for dimension-independent programming
+- Extensive documentation and working example programs
+- Locally refined grids
+- Continuous and discontinuous elements of higher order
+- Fast linear algebra
+- Built-in support for symmetric multi-processing (SMP)
+- Output for a variety of visualization platforms.
+
+deal.II can be downloaded for free and is distributed under an Open
+Source license.
+
+
+Wolfgang Bangerth, Ralf Hartmann, Guido Kanschat, the deal.II team
--- /dev/null
+Version 3.4 of the deal.II object-oriented finite element library has
+been released. It is available from the deal.II home-page at
+
+ http://www.dealii.org
+
+The most important changes compared to the previous version are:
+- A new homepage address at www.dealii.org
+- Two more example programs, explaining modern error estimation
+ techniques and showing software design methods allowing for modular
+ and extensible programs
+- Improved multi-threading supports using POSIX
+- Improved ISO C++ Standard conformance
+- Support for TECPLOT binary format and grid output in DX format
+- Three functions have been deprecated, and will be removed in the
+ next version.
+
+A complete list of changes with respect to the previous version can be
+found at
+ http://www.dealii.org/news/2002/3.3.0-vs-3.4.0.html
+
+All main features of the previous versions have been continued and
+improved:
+- Support for dimension-independent programming
+- Extensive documentation and working example programs
+- Locally refined grids
+- Continuous and discontinuous elements of higher order
+- Fast linear algebra
+- Built-in support for symmetric multi-processing (SMP)
+- Output for a variety of visualization platforms.
+
+deal.II can be downloaded for free and is distributed under an Open
+Source license.
+
+
+Wolfgang Bangerth, Ralf Hartmann, Guido Kanschat, the deal.II team
--- /dev/null
+After one year of development, version 4.0 of the deal.II
+object-oriented finite element library has been released. It is
+available from the deal.II home-page at
+
+ http://www.dealii.org
+
+This version features many new components. The most outstanding
+additions are
+- Support for Nedelec edge elements; in general, we now support
+ vector-valued elements where the vector components are coupled
+- An implementation of Q(r) elements with hierarchic shape functions
+- A new and simpler-to-use multi-threading scheme
+- A much faster scheme to read in grids in 2d
+- Support for more compilers and operating systems
+
+A comprehensive list of new features can be found at
+ http://www.dealii.org/news/3.4.0-vs-4.0.0.html
+
+All main features of the previous versions have been continued and
+improved:
+- Support for dimension-independent programming
+- Extensive documentation and working example programs
+- Locally refined grids
+- A zoo of different finite elements
+- Fast linear algebra
+- Built-in support for symmetric multi-processing (SMP)
+- Output for a variety of visualization platforms.
+
+deal.II can be downloaded for free and is distributed under an Open
+Source license.
+
+
+Wolfgang Bangerth, Ralf Hartmann, Guido Kanschat, the deal.II team
--- /dev/null
+After almost one year of development, version 5.0 of the deal.II
+object-oriented finite element library has been released. It is
+available from the deal.II home-page at
+
+ http://www.dealii.org
+
+Version 5.0 is another major step for this library. The most important
+change is the addition of interfaces to the PETSc library to provide a
+second set of linear system support classes besides the original
+deal.II ones. Via PETSc and an interface to METIS, parallel finite
+element computations on clusters of computers have become as simple as
+sequential ones. Through this, the library has proven to support
+computations with more than 10 million unknowns.
+
+In addition to this, the most noteworthy changes are:
+- Two new example programs, demonstrating one-dimensional nonlinear
+ problems and parallel computations with PETSc
+- The use of doxygen for the generation of our several-thousand pages
+ strong documentation, with significantly better cross-linking between
+ pages
+- Much better support for three-dimensional computations. Several
+ topological restrictions on unstructured 3d meshes have been lifted,
+ and a number of long-standing bugs have been fixed. We can now also
+ read in 3d meshes with several 100,000 cells in a few seconds
+- Support for Raviart-Thomas elements in 2d and 3d.
+- Support for more compilers and operating systems
+
+A comprehensive list of new features and fixed bugs can be found at
+ http://www.dealii.org/news/4.0.0-vs-5.0.0.html
+
+All main features of the previous versions have been continued and
+improved:
+- Support for dimension-independent programming
+- Extensive documentation and working example programs
+- Locally refined grids
+- A zoo of different finite elements
+- Fast linear algebra
+- Built-in support for symmetric multi-processing (SMP)
+- Output for a variety of visualization platforms.
+
+deal.II can be downloaded for free and is distributed under an Open
+Source license.
+
+
+Wolfgang Bangerth, Ralf Hartmann, Guido Kanschat, the deal.II team
--- /dev/null
+Version 5.1 of the deal.II object-oriented finite element library has been
+released. It is available from the deal.II home-page at
+
+ http://www.dealii.org/
+
+Version 5.1 offers a number of improvements over previous versions. In
+particular, it contains a version of the sparse direct solver package UMFPack,
+as well as corresponding interfaces to use it from within deal.II.
+
+In addition to this, the most noteworthy changes are:
+- Vectors and matrices built on top of PETSc objects are now completely
+ integrated. In particular, it is possible to build block vectors and
+ matrices with them.
+- In 3d, Lagrange elements now implement hanging node constraints for all
+ polynomial orders, not only for the first few
+- Several classes have been optimized to use algorithms with a better
+ complexity in terms of memory use or run time
+- Support for DLLs on Microsoft Windows.
+
+A comprehensive list of new features and fixed bugs can be found at
+ http://www.dealii.org/5.1.0/news/5.0.0-vs-5.1.0.html
+
+All main features of the previous versions have been continued and improved:
+- Support for dimension-independent programming
+- Extensive documentation and working example programs
+- Locally refined grids
+- A zoo of different finite elements
+- Fast linear algebra
+- Built-in support for symmetric multi-processing (SMP)
+- Output for a variety of visualization platforms.
+
+deal.II can be downloaded for free and is distributed under an Open
+Source license.
+
+
+Wolfgang Bangerth, Ralf Hartmann, Guido Kanschat, the deal.II team
--- /dev/null
+Version 5.2 of the deal.II object-oriented finite element library has been
+released. It is available from the deal.II home-page at
+
+ http://www.dealii.org/
+
+All main features of the previous versions have been continued and improved:
+- Support for dimension-independent programming
+- Extensive documentation and working example programs
+- Multigrid support
+- Locally refined grids
+- A zoo of different finite elements
+- Fast linear algebra
+- Built-in support for symmetric multi-processing (SMP) and distributed
+ computing
+- Petsc interface
+- Output for a variety of visualization platforms.
+
+A comprehensive list of almost 100 new features and fixed bugs can be found at
+ http://www.dealii.org/5.2.0/news/5.1.0-vs-5.2.0.html
+
+deal.II can be downloaded for free and is distributed under an Open
+Source license.
+
+
+Guido Kanschat, Wolfgang Bangerth, Ralf Hartmann, the deal.II team
--- /dev/null
+Version 6.0 of deal.II, the object-oriented finite element library
+recently awarded the J. H. Wilkinson Prize for Numerical Software, has
+been released. It is available from the deal.II home-page at
+
+ http://www.dealii.org/
+
+Major new features of version 6.0 are
+- support for hp-finite elements, continuous and discontinuous
+- handling of arbitrary hexahedral meshes in 3D
+- support for a wider variety of systems, including Mac OS X
+- 6 new extensive tutorial programs showing advanced FEM techniques
+- some 180 new functions, classes, and bug fixes.
+
+All main features of the previous versions have been continued and improved:
+- Support for dimension-independent programming
+- Extensive documentation and working example programs
+- Multigrid support
+- Locally refined grids
+- A zoo of different finite elements
+- Fast linear algebra
+- Built-in support for symmetric multi-processing (SMP) and distributed
+ computing
+- Interfaces to PETSc, METIS, UMFPACK and other external software
+- Output for a variety of visualization platforms.
+
+deal.II can be downloaded for free and is distributed under an Open
+Source license.
+
+
+Wolfgang Bangerth, Guido Kanschat, Ralf Hartmann, the deal.II team
--- /dev/null
+Version 6.1 of deal.II, the object-oriented finite element library
+recently awarded the J. H. Wilkinson Prize for Numerical Software, has
+been released. It is available from the deal.II home-page at
+
+ http://www.dealii.org/
+
+Major new features of version 6.1 are:
+- 3 new extensive tutorial programs showing advanced FEM techniques for
+ complex-valued problems, the Stokes equations, and the Euler equations of
+ compressible gas dynamics
+- Improved hp finite element support
+- A simpler and more powerful method to assemble matrices and vectors for
+ systems of partial differential equations
+- A method to postprocess numerical solutions and write derived quantities
+ into output files for graphical visualization
+- A much improved sparse ILU
+- Some 60 new functions, classes, and bug fixes.
+
+All main features of the previous versions have been continued and improved:
+- Support for dimension-independent programming
+- Extensive documentation and working example programs
+- Multigrid support
+- Locally refined grids
+- A zoo of different finite elements
+- Fast linear algebra
+- Built-in support for symmetric multi-processing (SMP) and distributed
+ computing
+- Interfaces to PETSc, METIS, UMFPACK and other external software
+- Output for a variety of visualization platforms.
+
+deal.II can be downloaded for free and is distributed under an Open
+Source license.
+
+
+Wolfgang Bangerth, Guido Kanschat, Ralf Hartmann, the deal.II team
--- /dev/null
+Version 6.2 of deal.II, the object-oriented finite element library
+recently awarded the J. H. Wilkinson Prize for Numerical Software, has
+been released. It is available for free under an OpenSource license
+from the deal.II home-page at
+
+ http://www.dealii.org/
+
+Major new features of version 6.2 are:
+- The ability to do anisotropic mesh refinement in both 2d and 3d
+- Support for meshes defined on curved manifolds, and the discretization
+ of partial differential or boundary integral equations on such domains
+- 4 new extensively documented tutorial programs demonstrating solving
+ boundary integral equations, the Boussinesq equations, anisotropic
+ mesh refinement, and an application from nuclear reactor engineering
+- Interfaces to the linear algebra classes in the Trilinos library
+- Support for vastly faster matrix assembly on structured meshes
+- Some 120 new functions, classes, and bug fixes.
+
+All main features of the previous versions have been continued and improved:
+- Support for dimension-independent programming
+- Extensive documentation and working example programs
+- Multigrid support
+- Locally refined grids
+- A zoo of different finite elements
+- Fast linear algebra
+- Built-in support for symmetric multi-processing (SMP) and distributed
+ computing
+- Interfaces to Trilinos, PETSc, METIS, UMFPACK and other external software
+- Output for a wide variety of visualization platforms.
+
+Wolfgang Bangerth, Guido Kanschat, Ralf Hartmann, and many others who
+contributed.
--- /dev/null
+Version 6.3 of deal.II, the object-oriented finite element library
+awarded the J. H. Wilkinson Prize for Numerical Software, has
+been released. It is available for free under an OpenSource license
+from the deal.II home-page at
+
+ http://www.dealii.org/
+
+Major new features of version 6.3 are:
+- Extension of the existing multigrid infrastructure to adaptively
+ refined meshes with continuous elements
+- The incorporation of the Intel Threading Building Blocks for scalable,
+ task-based parallelism on multicore machines throughout the library
+- A whole new framework with generic loops, simplifying integrals over meshes
+- 4 new extensively documented tutorial programs demonstrating multigrid on
+ adaptive meshes, projection solvers for the Navier-Stokes equations,
+ eigenvalue problems, and matrix free methods
+- Some 100 new functions, classes, and bug fixes.
+
+All main features of the previous versions have been continued and improved:
+- Support for dimension-independent programming
+- Extensive documentation and working example programs
+- Multigrid support
+- Locally refined grids
+- A zoo of different finite elements
+- Fast linear algebra
+- Built-in support for symmetric multi-processing (SMP) and distributed
+ computing
+- Interfaces to Trilinos, PETSc, METIS, UMFPACK and other external software
+- Output for a wide variety of visualization platforms.
+
+Wolfgang Bangerth, Guido Kanschat, Ralf Hartmann, and many others who
+contributed.
--- /dev/null
+Version 7.0 of deal.II, the object-oriented finite element library awarded the
+J. H. Wilkinson Prize for Numerical Software, has been released. It is
+available for free under an OpenSource license from the deal.II home-page at
+
+ http://www.dealii.org/
+
+Version 7.0 is a major step forward. Its new features include:
+- Support for massively parallel computations that has been shown to scale to
+ at least 16,384 processors and a new tutorial program that shows its
+ use. The user code for a massively parallel, fully adaptive Laplace solver
+ is only some 20 lines of code longer than its sequential version.
+- While 2d and 3d programs could always use almost exactly the same code,
+ dimension independent programming has become simpler by making sure that 1d
+ now works in exactly the same way.
+- A new tutorial program on the discretization of PDE on manifolds.
+- Nedelec elements are now available to arbitrary order.
+- deal.II is now linked into a single library.
+- A graphical user interface for input parameter files.
+
+All main features of the previous versions have been continued and improved:
+- Support for dimension-independent programming
+- Extensive documentation and working example programs
+- Locally refined adaptive meshes
+- Multigrid support
+- A zoo of different finite elements
+- Fast linear algebra
+- Built-in support for shared memory and distributed parallel computing
+- Interfaces to Trilinos, PETSc, METIS, UMFPACK and other external software
+- Output for a wide variety of visualization platforms.
+
+Wolfgang Bangerth, Guido Kanschat, Ralf Hartmann, and many other contributors.
--- /dev/null
+Version 7.1 of deal.II, the object-oriented finite element library awarded the
+J. H. Wilkinson Prize for Numerical Software, has been released. It is
+available for free under an Open Source license from the deal.II homepage at
+
+ http://www.dealii.org/
+
+This version has a large number of enhancements:
+- A tutorial program (step-32) demonstrating the solution of the Boussinesq
+ equation on hundreds or thousands of processors
+- A tutorial program (step-46) solving a fluid-structure interaction problem
+ and showing how to implement problems in which different equations hold in
+ different parts of the domain
+- Improved support for massively large computations and for multiphysics
+ problems throughout the library
+- Support for serialization of most classes to allow checkpoint/restart
+- More robust interfaces to Trilinos and PETSc
+- More than 100 other changes and bug fixes throughout the library.
+
+All main features of the previous versions have been continued and improved:
+- Support for dimension-independent programming
+- Extensive documentation and 40 working example programs
+- Locally refined adaptive meshes
+- Multigrid support
+- A zoo of different finite elements
+- Fast linear algebra
+- Built-in support for shared memory and distributed parallel computing,
+ scaling from laptops to clusters with 10,000s of processor cores
+- Interfaces to Trilinos, PETSc, METIS, UMFPACK and other external software
+- Output for a wide variety of visualization platforms.
+
+Wolfgang Bangerth, Guido Kanschat, Timo Heister, and many other contributors.
--- /dev/null
+Version 7.2 of deal.II, the object-oriented finite element library awarded the
+J. H. Wilkinson Prize for Numerical Software, has been released. It is
+available for free under an Open Source license from the deal.II homepage at
+
+ http://www.dealii.org/
+
+This version has a large number of enhancements:
+- A framework for matrix-free finite element computations, with support
+ for both intra-node parallelism and massively parallel inter-node
+ computations, together with two tutorial programs that show how this can be
+ used (step-37, step-48)
+- A tutorial program demonstrating advanced techniques for
+ multiphase flow (step-43)
+- Three tutorial programs showing how to solve variational inequalities (the
+ obstacle problem, step-41), finite strain elasticity (step-44), and a
+ rewritten introduction to nonlinear problems (step-15)
+- Support for problems with codimension 2, for example for solving problems on
+ a line embedded into R^3
+- Distributed triangulations now provide checkpoint/restart functionality
+- Support for parallel output using HDF5/xdmf
+- More than 100 other changes and bug fixes throughout the library.
+
+All main features of the previous versions have been continued and improved:
+- Extensive documentation and 45 working example programs
+- Support for dimension-independent programming
+- Locally refined adaptive meshes
+- Multigrid support
+- A zoo of different finite elements
+- Fast linear algebra
+- Built-in support for shared memory and distributed parallel computing,
+ scaling from laptops to clusters with 10,000s of processor cores
+- Interfaces to Trilinos, PETSc, METIS, UMFPACK and other external software
+- Output for a wide variety of visualization platforms.
+
+Wolfgang Bangerth, Timo Heister, Guido Kanschat, and many other contributors.
--- /dev/null
+Version 7.3 of deal.II, the object-oriented finite element library awarded the
+J. H. Wilkinson Prize for Numerical Software, has been released. It is
+available for free under an Open Source license from the deal.II homepage at
+
+ http://www.dealii.org/
+
+This version is primarily a maintenance release. It makes a significant part
+of the handling of linear algebra objects across the various supported
+libraries (native, via PETSc and via Trilinos) more consistent in their
+interfaces. In addition, it also contains a new tutorial program demonstrating
+various ways of generating meshes, introduces better iterators into sparsity
+patterns and sparse matrices, and has better ways to deal with multicomponent
+problems. Release 7.3 is backward compatible to 7.2. However, it deprecates a
+number of classes and functions that will be removed in the next release.
+
+All main features of the previous versions have been continued and improved:
+- Extensive documentation and 46 working example programs
+- Support for dimension-independent programming
+- Locally refined adaptive meshes
+- Multigrid support
+- A zoo of different finite elements
+- Fast linear algebra
+- Built-in support for shared memory and distributed parallel computing,
+ scaling from laptops to clusters with 10,000s of processor cores
+- Interfaces to Trilinos, PETSc, METIS, UMFPACK and other external software
+- Output for a wide variety of visualization platforms.
+
+Wolfgang Bangerth, Timo Heister, Guido Kanschat, and many other contributors.
--- /dev/null
+Version 8.0 of deal.II, the object-oriented finite element library awarded the
+J. H. Wilkinson Prize for Numerical Software, has been released. It is
+available for free under an Open Source license from the deal.II homepage at
+
+ http://www.dealii.org/
+
+This is a major new release. In particular, it features the following changes:
+- The configuration and build system has been switched to cmake, providing
+ better support for a wide variety of platforms including Microsoft Windows,
+ better integration with IDEs such as Eclipse, and many other advantages.
+- deal.II now supports 64bit indices for problems with more than 2
+ billion unknowns and has been tested on problems of up to 27 billion
+ unknowns.
+- deal.II is now licensed under the LGPL.
+
+Further changes include:
+- Improvements to parallel linear algebra
+- Improvements to multithreading
+- Hundreds of new features and bugfixes
+
+The main features of deal.II are:
+- Extensive documentation and 46 working example programs
+- Support for dimension-independent programming
+- Locally refined adaptive meshes
+- Multigrid support
+- A zoo of different finite elements
+- Fast linear algebra
+- Built-in support for shared memory and distributed parallel computing,
+ scaling from laptops to clusters with 10,000s of processor cores
+- Interfaces to Trilinos, PETSc, METIS, UMFPACK and other external software
+- Output for a wide variety of visualization platforms.
+
+Wolfgang Bangerth, Timo Heister, Guido Kanschat, and many other contributors.
--- /dev/null
+Version 8.1 of deal.II, the object-oriented finite element library awarded the
+J. H. Wilkinson Prize for Numerical Software, has been released. It is
+available for free under an Open Source license from the deal.II homepage at
+
+ http://www.dealii.org/
+
+This version is primarily a maintenance release but still has a number of
+noteworthy new features:
+- Three new tutorial programs on elasto-plastic contact problems (step-42),
+ hybridizable dicontinuous Galerkin methods (step-51), and a simple example
+ of using adaptive mesh refinement for time dependent problems (step-26)
+- Significantly better support for shared memory multicore parallelism
+- Dozens of new features and bugfixes
+
+For more information see http://arxiv.org/abs/1312.2266v4
+
+Wolfgang Bangerth, Timo Heister, Guido Kanschat, and many other contributors.
--- /dev/null
+Version 8.2 of deal.II, the object-oriented finite element library awarded the
+J. H. Wilkinson Prize for Numerical Software, has been released. It is
+available for free under an Open Source license from the deal.II homepage at
+
+ http://www.dealii.org/
+
+This version has a significant number of noteworthy new features:
+- Comprehensive support for geometries described by arbitrary manifolds
+ and meshes that respect this description not only on the boundary but
+ also internally
+- Support for geometries imported from CAD using the OpenCASCADE library
+- Three new tutorial programs on complex geometries, CAD geometries, and
+ time stepping methods
+- Support for users wanting to use C++11 features
+- Improvements to multithreading support
+- Vectorization of many vector operations using OpenMP SIMD directives
+- At least 140 features and bugfixes
+
+For more information see
+ https://journals.ub.uni-heidelberg.de/index.php/ans/article/view/18031 (release paper)
+ https://www.dealii.org/8.2.1/doxygen/deal.II/changes_between_8_1_and_8_2.html (changelog)
+
+Wolfgang Bangerth, Timo Heister, Guido Kanschat, Matthias Maier,
+and many other contributors.
--- /dev/null
+Version 8.3 of deal.II, the object-oriented finite element library awarded the
+J. H. Wilkinson Prize for Numerical Software, has been released. It is
+available for free under an Open Source license from the deal.II homepage at
+
+ https://www.dealii.org/
+
+The major changes of this release are:
+- Improved handling of parallel distributed meshes, including a better
+ numbering of cells on coarse meshes based on a hierarchical concept instead
+ of Cuthill-McKee numbering.
+- New abstract C++11 interface to linear operators.
+- All examples have been changed to use the new DynamicSparsityPattern.
+- Improved support for periodic boundary conditions with arbitrary
+ orientations.
+- New quadrature formulas.
+- Full conversion to the new manifold mechanism (manifold_id) for boundary
+ descriptions.
+- Better support for complex-valued problems by doing internal arithmetic in
+ the correct data types, rather than defaulting to double precision.
+- An implementation of Bernstein polynomial-based finite elements.
+- Interface to the new algebraic multilevel package MueLu of the Trilinos
+ project.
+- More descriptive exception messages in many places for improved user
+ productivity in code development.
+- More than 140 other features and bugfixes.
+
+For more information see
+- the preprint at https://www.dealii.org/deal83-preprint.pdf
+- the list of changes at
+ https://www.dealii.org/8.3.0/doxygen/deal.II/changes_between_8_2_1_and_8_3.html
+
+The main features of deal.II are:
+- Extensive documentation and 52 working example programs
+- Support for dimension-independent programming
+- Locally refined adaptive meshes
+- Multigrid support
+- A zoo of different finite elements
+- Fast linear algebra
+- Built-in support for shared memory and distributed parallel computing,
+ scaling from laptops to clusters with 10,000s of processor cores
+- Interfaces to Trilinos, PETSc, METIS, UMFPACK and other external software
+- Output for a wide variety of visualization platforms.
+
+Wolfgang Bangerth, Timo Heister, Guido Kanschat, Matthias Maier,
+and many other contributors.
--- /dev/null
+Version 8.3 of deal.II, the object-oriented finite element library awarded the
+J. H. Wilkinson Prize for Numerical Software, has been released. It is
+available for free under an Open Source license from the deal.II homepage at
+
+ https://www.dealii.org/
+
+Among the major changes of this release are:
+- Improved handling of parallel distributed meshes.
+- New abstract C++11 interface to linear operators.
+- Conversion of tutorials to the new manifold mechanism for boundary descriptions.
+- Better support for complex-valued problems.
+- More descriptive exception messages in many places.
+- More than 140 other features and bugfixes.
+
+For more information see the preprint at https://www.dealii.org/deal83-preprint.pdf
+and the full list of changes at
+ https://www.dealii.org/8.3.0/doxygen/deal.II/changes_between_8_2_1_and_8_3.html
+
+The main features of deal.II are:
+- Extensive documentation and 52 working example programs
+- Support for dimension-independent programming
+- Locally refined adaptive meshes and multigrid support
+- A zoo of different finite elements
+- Built-in support for shared memory and distributed parallel computing,
+ scaling from laptops to clusters with 10,000s of processor cores
+- Interfaces to Trilinos, PETSc, METIS, UMFPACK and other external software
+- Output for a wide variety of visualization platforms.
+
+Wolfgang Bangerth, Timo Heister, Guido Kanschat, Matthias Maier,
+and many other contributors.
--- /dev/null
+Version 8.4 of deal.II, the object-oriented finite element library awarded the
+J. H. Wilkinson Prize for Numerical Software, has been released. It is
+available for free under an Open Source license from the deal.II homepage at
+
+ https://www.dealii.org/
+
+The major changes of this release are:
+- Parallel triangulations can now be partitioned in ways that allow weighting
+ cells differently.
+- Improved support for complex numbers throughout the library.
+- A new triangulation type that supports parallel computations but ensures
+ that the entire mesh is available on every processor.
+- An implementation of the Rannacher-Turek element, as well as an element that
+ extends the usual Q(p) elements by bubble functions.
+- Second and third derivatives of finite element fields are now computed
+ exactly.
+- The interface between finite elements, quadrature, mapping, and the FEValues
+ class has been rewritten. It is now much better documented.
+- Initial support for compiling with Visual C++ 2013 and 2015 under Windows
+ has been added.
+- Where possible, the 'gold' linker is used, dramatically speeding up linking
+- More than 140 other features and bugfixes.
+
+For more information see
+- the preprint at https://www.dealii.org/deal84-preprint.pdf
+- the list of changes at
+ https://www.dealii.org/8.4.0/doxygen/deal.II/changes_between_8_3_and_8_4.html
+
+The main features of deal.II are:
+- Extensive documentation and 52 working example programs
+- Support for dimension-independent programming
+- Locally refined adaptive meshes
+- Multigrid support
+- A zoo of different finite elements
+- Fast linear algebra
+- Built-in support for shared memory and distributed parallel computing,
+ scaling from laptops to clusters with 10,000s of processor cores
+- Interfaces to Trilinos, PETSc, METIS, UMFPACK and other external software
+- Output for a wide variety of visualization platforms.
+
+Wolfgang Bangerth, Timo Heister, Guido Kanschat, Matthias Maier,
+and many other contributors.