From: Tonatiuh Sanchez-Vizuet Date: Thu, 8 Aug 2019 17:35:09 +0000 (-0600) Subject: Added some references to the intro of step 51 X-Git-Tag: v9.2.0-rc1~1261^2~1 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=4d722da333f529cfc6926a7518a4ff56d6c3aa2f;p=dealii.git Added some references to the intro of step 51 --- diff --git a/doc/doxygen/references.bib b/doc/doxygen/references.bib index 25a58ec935..3a3ee517cf 100644 --- a/doc/doxygen/references.bib +++ b/doc/doxygen/references.bib @@ -242,7 +242,9 @@ pages = {1093--1112} } - +% ------------------------------------ +% Step 51 +% ------------------------------------ @article {Ngu2012, AUTHOR = {Nguyen, N. C. and Peraire, J.}, @@ -261,3 +263,46 @@ URL = {https://doi.org/10.1016/j.jcp.2012.02.033}, } +@incollection{F65, + author = {Fraeijs de Veubeke, B. X.}, + title = {Displacement and equilibrium models in the finite element method}, + booktitle = {Stress Analysis}, + publisher = {Wiley, New York}, + editor = {Zienkiewicz, O. C. and Holister, G. S.}, + year = {1965}, + pages = {275-284}, + URL = {https://ci.nii.ac.jp/naid/10003737730/en/}, +} + +@article{G65, + doi = {10.2514/3.2874}, + url = {https://doi.org/10.2514/3.2874}, + year = {1965}, + month = {feb}, + publisher = {American Institute of Aeronautics and Astronautics ({AIAA})}, + volume = {3}, + number = {2}, + pages = {380--380}, + author = {R. J. Guyan}, + title = {Reduction of stiffness and mass matrices}, + journal = {{AIAA} Journal} +} + +@article {CGL2009, + AUTHOR = {Cockburn, Bernardo and Gopalakrishnan, Jayadeep and Lazarov, Raytcho}, + TITLE = {Unified hybridization of discontinuous {G}alerkin, mixed, and + continuous {G}alerkin methods for second order elliptic + problems}, + JOURNAL = {SIAM J. Numer. Anal.}, + FJOURNAL = {SIAM Journal on Numerical Analysis}, + VOLUME = {47}, + YEAR = {2009}, + NUMBER = {2}, + PAGES = {1319--1365}, + ISSN = {0036-1429}, + MRCLASS = {65N30}, + MRNUMBER = {2485455}, +MRREVIEWER = {Jose Luis Gracia}, + DOI = {10.1137/070706616}, + URL = {http://dx.doi.org/10.1137/070706616}, +} diff --git a/doc/news/changes/minor/20190807Sanchez-Vizuet b/doc/news/changes/minor/20190807Sanchez-Vizuet new file mode 100644 index 0000000000..36e3fc0553 --- /dev/null +++ b/doc/news/changes/minor/20190807Sanchez-Vizuet @@ -0,0 +1,3 @@ +Changed: Added references to intro of step 51. Included the references in the bibliography +
+(Tonatiuh Sanchez-Vizuet 2019/08/08) diff --git a/examples/step-51/doc/intro.dox b/examples/step-51/doc/intro.dox index 501ee4124c..676e2169b1 100644 --- a/examples/step-51/doc/intro.dox +++ b/examples/step-51/doc/intro.dox @@ -29,13 +29,13 @@ for systems of equations in 2 or 3 dimensions.

Reducing the size of the linear system

To alleviate the computational cost of solving such large linear systems, the hybridizable discontinuous Galerkin (HDG) methodology was introduced -by Cockburn and co-workers -(see the references in the recent HDG overview article by N.C. Nguyen and J. Peraire @cite Ngu2012). -The HDG method achieves -this goal by formulating the mathematical problem using Dirichlet-to-Neumann -mappings. The partial differential equations are first written as a first -order system, and each field is then discretized via a DG method. At this -point, the single-valued "trace" values on the skeleton of the +by Cockburn and co-workers (see the references in the recent HDG overview +article by Nguyen and Peraire @cite Ngu2012). + +The HDG method achieves this goal by formulating the mathematical problem using +Dirichlet-to-Neumann mappings. The partial diffeirential equations are first +written as a first order system, and each field is then discretized via a DG +method. At this point, the single-valued "trace" values on the skeleton of the mesh, i.e., element faces, are taken to be independent unknown quantities. This yields unknowns in the discrete formulation that fall into two categories: - Face unknowns that only couple with the cell unknowns from both sides of the face; @@ -50,16 +50,27 @@ The Dirichlet-to-Neumann map concept then permits the following solution procedu skeleton of the triangulation. The global problem is then to solve for the trace values, which are the only globally coupled unknowns.
  • Use the known skeleton values as Dirichlet data for solving local -element-level solutions. This is known as the -'local solver', and is an embarrassingly parallel element-by-element -solution process. +element-level solutions. This is known as the 'local solver', and is an +embarrassingly parallel element-by-element solution process. -The above procedure also has a linear algebra interpretation and is referred to -as static condensation. Let us write the complete linear system associated to -the HDG problem as a block system with the discrete DG (cell interior) -variables $U$ as first block and the skeleton (face) variables $\Lambda$ as the -second block: +

    Relation with Static Condensation

    +The above procedure also has a linear algebra interpretation---referred to +as static condensation---that was exploited to reduce the size of the +global linear system by Guyan in the context of continuous Finite Elements +@cite G65, and by Fraeijs de Veubeke for mixed methods @cite F65. In the +latter case (mixed formulation), the system reduction was achieved through the +use of discontinuous fluxes combined with the introduction of an additional +auxiliary hybrid variable that approximates the trace of the unknown +at the boundary of every element. This procedure became known as hybridization +and---by analogy---is the reason why the local discontinuous Galerkin method +introduced by Cockburn, Gopalakrishnan, and Lazarov in 2009 @cite CGL2009, and +subsequently developed by their collaborators, eventually came to be known as +the hybridizable discontinuous Galerkin (HDG) method. + +Let us write the complete linear system associated to the HDG problem as a +block system with the discrete DG (cell interior) variables $U$ as first block +and the skeleton (face) variables $\Lambda$ as the second block: @f{eqnarray*} \begin{pmatrix} A & B \\ C & D \end{pmatrix} \begin{pmatrix} U \\ \Lambda \end{pmatrix} @@ -79,10 +90,12 @@ The coupling to other cells is introduced by the matrices $B$ and $C$ over the skeleton variable. The block-diagonality of $A$ and the structure in $B$ and $C$ allow us to invert the matrix $A$ element by element (the local solution of the Dirichlet -problem) and subtract $CA^{-1}B$ from $D$. The steps in the Dirichlet-to-Neumann map concept hence correspond to +problem) and subtract $CA^{-1}B$ from $D$. The steps in the Dirichlet-to-Neumann +map concept hence correspond to
      -
    1. constructing the Schur complement matrix $D-C A^{-1} B$ and right hand side $G - C A^{-1} F$ locally on each cell - and inserting the contribution into the global trace matrix in the usual way, +
    2. constructing the Schur complement matrix $D-C A^{-1} B$ and right hands +side $G - C A^{-1} F$ locally on each cell +and inserting the contribution into the global trace matrix in the usual way,
    3. solving the Schur complement system for $\Lambda$, and
    4. solving for $U$ using the second equation, given $\Lambda$.
    @@ -350,7 +363,8 @@ Note that the convection is divergence-free, $\nabla \cdot c = 0$.

    Implementation

    -Besides implementing the above equations, the implementation below provides the following features: +Besides implementing the above equations, the implementation below provides +the following features: