]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Added some references to the intro of step 51
authorTonatiuh Sanchez-Vizuet <tonatiuh@udel.edu>
Thu, 8 Aug 2019 17:35:09 +0000 (11:35 -0600)
committerDavid Wells <drwells@email.unc.edu>
Mon, 12 Aug 2019 00:39:09 +0000 (20:39 -0400)
doc/doxygen/references.bib
doc/news/changes/minor/20190807Sanchez-Vizuet [new file with mode: 0644]
examples/step-51/doc/intro.dox

index 25a58ec9353e75f28ed7b0bbbb59e7a1d4c9b99a..3a3ee517cf0d0c2304f94d5a6b85b8cc53210b3a 100644 (file)
   pages =   {1093--1112}
 }
 
-
+% ------------------------------------
+% Step 51
+% ------------------------------------
 
 @article {Ngu2012,
     AUTHOR = {Nguyen, N. C. and Peraire, J.},
        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 (file)
index 0000000..36e3fc0
--- /dev/null
@@ -0,0 +1,3 @@
+Changed: Added references to intro of step 51. Included  the references in the bibliography
+<br>
+(Tonatiuh Sanchez-Vizuet 2019/08/08)
index 501ee4124c93c6901c3615aafc487907d55a7d09..676e2169b1d8f14b3f9bc26452bf797006105429 100644 (file)
@@ -29,13 +29,13 @@ for systems of equations in 2 or 3 dimensions.
 <h4> Reducing the size of the linear system </h4>
 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.
   <li>  Use the known skeleton values as Dirichlet data for solving local
-element-level solutions.  This is known as the
-'local solver', and is an <i>embarrassingly parallel</i> element-by-element
-solution process.
+element-level solutions.  This is known as the 'local solver', and is an 
+<i>embarrassingly parallel</i> element-by-element solution process.
 </ol>
 
-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:
+<h4> Relation with Static Condensation </h4>
+The above procedure also has a linear algebra interpretation---referred to
+as <i>static condensation</i>---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 <i>hybrid</i> 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 <i>hybridizable discontinuous Galerkin</i> (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
 <ol>
-  <li> constructing the Schur complement matrix $D-C A^{-1} B$ and right hand side $G - C A^{-1} F$  <i>locally on each cell</i>
-  and inserting the contribution into the global trace matrix in the usual way,
+  <li> constructing the Schur complement matrix $D-C A^{-1} B$ and right hands
+side $G - C A^{-1} F$  <i>locally on each cell</i>
+and inserting the contribution into the global trace matrix in the usual way,
   <li> solving the Schur complement system for $\Lambda$, and
   <li> solving for $U$ using the second equation, given $\Lambda$.
 </ol>
@@ -350,7 +363,8 @@ Note that the convection is divergence-free, $\nabla \cdot c = 0$.
 
 <h3> Implementation </h3>
 
-Besides implementing the above equations, the implementation below provides the following features:
+Besides implementing the above equations, the implementation below provides
+the following features:
 <ul>
   <li> WorkStream to parallelize local solvers. Workstream has been presented
   in detail in step-9.

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.