From caf659bf989a15c58a7f908a01336cf8e8a4ceb8 Mon Sep 17 00:00:00 2001 From: wolf Date: Fri, 31 Mar 2000 11:43:41 +0000 Subject: [PATCH] Add several new papers. git-svn-id: https://svn.dealii.org/trunk@2652 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/doc/publications/2000/bangerth-2.html | 30 +++++++++++ deal.II/doc/publications/2000/bangerth-3.html | 50 +++++++++++++++++++ deal.II/doc/publications/2000/hartmann-1.html | 37 ++++++++++++++ deal.II/doc/publications/toc.html | 39 +++++++++++++++ 4 files changed, 156 insertions(+) create mode 100644 deal.II/doc/publications/2000/bangerth-2.html create mode 100644 deal.II/doc/publications/2000/bangerth-3.html create mode 100644 deal.II/doc/publications/2000/hartmann-1.html diff --git a/deal.II/doc/publications/2000/bangerth-2.html b/deal.II/doc/publications/2000/bangerth-2.html new file mode 100644 index 0000000000..9dc4070bd5 --- /dev/null +++ b/deal.II/doc/publications/2000/bangerth-2.html @@ -0,0 +1,30 @@ + + + + + + The deal.II Homepage + + + + + +

Abstract:

+ + In this report, we describe the implementational techniques of + multi-threading support in deal.II, which we use for the + parallelization of independent operations. Writing threaded programs in + C++ is obstructed by two problems: operating system dependent + interfaces and that these interfaces are created for C programs + rather than for C++. We present our solutions to these problems and + describe first experiences using multi-threading in deal.II. + +

+


+
+Wolfgang Bangerth +
2000-03-31 +
+ + diff --git a/deal.II/doc/publications/2000/bangerth-3.html b/deal.II/doc/publications/2000/bangerth-3.html new file mode 100644 index 0000000000..6f134bd468 --- /dev/null +++ b/deal.II/doc/publications/2000/bangerth-3.html @@ -0,0 +1,50 @@ + + + + + + The deal.II Homepage + + + + + +

Abstract:

+ +

+ Modern finite element software tends to become increasingly complex. + Techniques like adaptive meshes, error estimation, multigrid methods, or + hp finite elements require the programmer to work with extremely + complicated data structures and sophisticated algorithms. Designing programs + in a maintainable and expandable way while retaining run time efficiency has + therefore become a major task in applied numerical analysis. In our + experience, this task can only be fulfilled by using modern programming + languages and tools. +

+ +

+ We will show how modern aspects of the C++ programming language, in + particular templates, can be used to write algorithms for finite element + programs in a dimension-independent way. This enables us to test algorithms + in one or two space dimensions while using the same program for large scale + computations in three space dimensions as well. It will be demonstrated that + this is even possible without much loss in efficiency since tests for the + actual space dimension at run time can almost completely be avoided. +

+ +

+ The idiom above is one of several modern aspects of C++ used in the design + of the finite element library deal.II developed at the University + of Heidelberg. We will give a sketch of its implementation and examples how + it is used. +

+
+

+


+
+Wolfgang Bangerth +
2000-03-31 +
+ + diff --git a/deal.II/doc/publications/2000/hartmann-1.html b/deal.II/doc/publications/2000/hartmann-1.html new file mode 100644 index 0000000000..aba18e9ab9 --- /dev/null +++ b/deal.II/doc/publications/2000/hartmann-1.html @@ -0,0 +1,37 @@ + + + + + + The deal.II Homepage + + + + + +

Abstract:

+ + + We present an approach to solving conservation equations by the + adaptive discontinuous Galerkin finite element method + (DG-method). Using a global duality argument and Galerkin + orthogonality, we obtain a residual-based error representation for the + error with respect to an arbitrary functional of the solution. This + results in local indicators that can be evaluated numerically and + which are used for adaptive mesh refinement and coarsening. In this + way, very economical and highly localized meshes can be generated + which are tailored to the cost-efficient computation of the quantity + of interest. We demonstrate the main ingredients of this approach of a + posteriori error estimation, test the quality of the error estimator + and the efficiency of the meshes by some numerical examples. + + +

+


+
+Ralf Hartmann +
2000-03-31 +
+ + diff --git a/deal.II/doc/publications/toc.html b/deal.II/doc/publications/toc.html index e8edba26b4..f77a8967ff 100644 --- a/deal.II/doc/publications/toc.html +++ b/deal.II/doc/publications/toc.html @@ -50,9 +50,48 @@ BibTeX entry)

+ +
  • + Ralf Hartmann +
    + Adaptive FE-Methods for Conservation Equations + +
    + In preparation +
    + (Abstract) +

    + +
  • + Wolfgang Bangerth +
    + Multi-threading support in deal.II + +
    + Pending acceptance as preprint at the University of Heidelberg +
    + (Abstract) +

    + +
  • + Wolfgang Bangerth +
    + Using Modern Features of C++ for Adaptive Finite + Element Methods: + Dimension-Independent Programming in deal.II + +
    + Submitted for the Proceedings of the 16th IMACS World + Congress, 2000 +
    + (Abstract) +

    +

    Publications in 1999

      -- 2.39.5