]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Reference the glossary entry relating to the lumped mass matrix. 14830/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Fri, 24 Feb 2023 11:52:20 +0000 (04:52 -0700)
committerWolfgang Bangerth <bangerth@colostate.edu>
Mon, 27 Feb 2023 21:49:28 +0000 (14:49 -0700)
doc/doxygen/headers/glossary.h
examples/step-69/doc/intro.dox
examples/step-69/step-69.cc
include/deal.II/matrix_free/operators.h

index d93eb2a96e6f63b7ea34bf36a32f4df3b57c8473..3ce24633795cb4fdb518614bf48440cde7cdf729 100644 (file)
  * where the sum extends over those cells on which $\varphi_i$ is nonzero.
  * The so-computed mass matrix is therefore diagonal.
  *
- * Whether or not this particular choice of quadrature formula is sufficient
- * to retain the convergence rate of the discretization is a separate
- * question. For the usual $Q_k$ finite elements, the appropriate
- * quadrature formulas are of QGaussLobatto type.
+ * Whether or not this particular choice of quadrature formula is
+ * sufficient to retain the convergence rate of the discretization is
+ * a separate question. For the usual $Q_k$ finite elements
+ * (implemented by FE_Q and FE_DGQ), the appropriate quadrature
+ * formulas are of QGaussLobatto type. Mass lumping can also be done
+ * with FE_SimplexP_Bubbles, for example, if appropriate quadrature rules
+ * are chosen.
+ *
+ * For an example of where lumped mass matrices play a role, see step-69.
  * </dd>
  *
  *
index 15acd85da702baefe9aa9b8af5b3b8933dc83c38..edafa046b66f942fee5a4b587d826cc26738bc75 100644 (file)
@@ -267,7 +267,8 @@ the (explicit time stepping) scheme as:
 @f}
 where
   - $m_i \dealcoloneq \int_{\Omega} \phi_i \, \mathrm{d}\mathbf{x}$
-    is the lumped @ref GlossMassMatrix "mass matrix"
+    is the @ref GlossLumpedMassMatrix "lumped"
+    @ref GlossMassMatrix "mass matrix"
   - $\tau$ is the time step size
   - $\mathbf{c}_{ij} \dealcoloneq \int_{\Omega} \nabla\phi_j\phi_i \,
     \mathrm{d}\mathbf{x}$ (note that $\mathbf{c}_{ij}\in \mathbb{R}^d$)
index 7e229edfa1d3a689a0377ba960effac904e31739..c013a95546c01d5ee39a13cd9f145562e9493772 100644 (file)
@@ -178,7 +178,9 @@ namespace Step69
   //
   // The class <code>OfflineData</code> contains pretty much all components
   // of the discretization that do not evolve in time, in particular, the
-  // DoFHandler, SparsityPattern, boundary maps, the lumped @ref GlossMassMatrix "mass matrix",
+  // DoFHandler, SparsityPattern, boundary maps, the
+  // @ref GlossLumpedMassMatrix "lumped" lumped
+  // @ref GlossMassMatrix "mass matrix",
   // $\mathbf{c}_{ij}$ and $\mathbf{n}_{ij}$ matrices. Here, the term
   // <i>offline</i> refers to the fact that all the class
   // members of <code>OfflineData</code> have well-defined values
index 647c85a1db345cb6828fc6da0d7ccfce8db56eee..f6bfcfe0d9bf63a56b982f6217f73c807f2c8239 100644 (file)
@@ -766,7 +766,8 @@ namespace MatrixFreeOperators
     compute_diagonal() override;
 
     /**
-     * Compute the lumped @ref GlossMassMatrix "mass matrix". This is equal to the mass matrix times a
+     * Compute the @ref GlossLumpedMassMatrix "lumped mass matrix".
+     * This is equal to the mass matrix times a
      * vector of all ones and is equivalent to approximating the mass matrix
      * with a nodal quadrature rule.
      *

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.