]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Adjust comments regarding Gauss-Lobatto polynomials
authorMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Tue, 5 Apr 2016 12:50:17 +0000 (14:50 +0200)
committerMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Sat, 9 Apr 2016 13:49:09 +0000 (15:49 +0200)
examples/step-48/doc/intro.dox
examples/step-48/step-48.cc

index a4715e6f80cf123265e0c4964356b9b20214947b..02562f5322c0ebec12cd7094716543419733c538 100644 (file)
@@ -15,20 +15,20 @@ International Conference on e-Science, 2011.  </i>
 <a name="Intro"></a>
 <h1>Introduction</h1>
 
-This program demonstrates how to use the cell-based implementation of
-finite element operators with the MatrixFree class,
-first introduced in step-37, to solve nonlinear partial
-differential equations. Moreover, we demonstrate how the
-MatrixFree class handles constraints and how it can be
-parallelized over distributed nodes. Finally, we will use an explicit
-time-stepping method to solve the problem and introduce Gauss-Lobatto
-finite elements that are very convenient in this case since they have
-a diagonal, and thus trivially invertible, mass matrix. Moreover,
-this type of elements clusters the nodes towards the element
-boundaries which is why they have good properties for high-order
-discretization methods. Indeed, the condition number of standard FE_Q
-elements with equidistant nodes grows exponentially with the degree,
-which destroys any benefit for orders of about five and higher.
+This program demonstrates how to use the cell-based implementation of finite
+element operators with the MatrixFree class, first introduced in step-37, to
+solve nonlinear partial differential equations. Moreover, we demonstrate how
+the MatrixFree class handles constraints and how it can be parallelized over
+distributed nodes. Finally, we will use an explicit time-stepping method to
+solve the problem and introduce Gauss-Lobatto finite elements that are very
+convenient in this case since they have a diagonal, and thus trivially
+invertible, mass matrix. Moreover, this type of elements clusters the nodes
+towards the element boundaries which is why they have good properties for
+high-order discretization methods. Indeed, the condition number of an FE_Q
+elements with equidistant nodes grows exponentially with the degree, which
+destroys any benefit for orders of about five and higher. For this reason,
+Gauss-Lobatto points are actually the default for FE_Q (but at degrees one and
+two, those are equivalent to the equidistant points).
 
 <h3> Problem statement and discretization </h3>
 
@@ -73,7 +73,7 @@ of finite elements of degree <i>p</i> is <i>p+1</i>, the overall
 convergence properties are not disturbed by the quadrature error, in
 particular not when we use high orders.
 
-Apart from the fact, that we avoid solving linear systems with this
+Apart from the fact that we avoid solving linear systems with this
 type of elements when using explicit time-stepping, they come with two
 other advantages. When we are using the sum-factorization approach to
 evaluate the finite element operator (cf. step-37), we have to
@@ -84,7 +84,7 @@ of the function at the quadrature points is given by its one-dimensional
 coefficients. In this way, the complexity of a finite element operator
 evaluation is further reduced compared to equidistant elements.
 
-The third advantage is the fact that these elements are better conditioned as
+The third advantage is the fact that these elements are better conditioned than
 equidistant Lagrange polynomials for increasing order so that we can use
 higher order elements for an accurate solution of the equation. Lagrange
 elements FE_Q with equidistant points should not be used for polynomial
index bd3d0b5c7eafe077c7de1452468b3a0b73dfcbd8..24e7c5694b81b21086010d63675ab35f09db26a0 100644 (file)
@@ -322,7 +322,10 @@ namespace Step48
   // are convenient because in conjunction with a QGaussLobatto quadrature
   // rule of the same order they give a diagonal mass matrix without
   // compromising accuracy too much (note that the integration is inexact,
-  // though), see also the discussion in the introduction.
+  // though), see also the discussion in the introduction. Note that FE_Q
+  // selects the Gauss-Lobatto nodal points by default due to their improved
+  // conditioning versus equidistant points. To make things more explicit, we
+  // choose to state the selection of the nodal points nonetheless.
   template <int dim>
   SineGordonProblem<dim>::SineGordonProblem ()
     :

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.