New: The new class MatrixFreeTools::ElementActivationAndDeactivationMatrixFree
is a wrapper around MatrixFree designed to deal with
DoFHandler objects involving cells without degrees of freedom, i.e.,
- cells using FENothing as element type. The class helps to implement the
+ cells using FE_Nothing as element type. The class helps to implement the
"element birth and death technique".
<br>
(Peter Munch, Sebastian Proell, 2022/07/09)
Changed:
-FE_DGQ::get_interpolation_matrix() now also takes as a source element FENothing.
+FE_DGQ::get_interpolation_matrix() now also takes as a source element FE_Nothing.
<br>
(Magdalena Schreter, Peter Munch, 2024/01/18)
-Fixed: Fix make_flux_sparsity_pattern for a FECollection containing FENothing elements.
+Fixed: Fix make_flux_sparsity_pattern for a FECollection containing FE_Nothing elements.
<br>
(Magdalena Schreter-Fleischhacker, Andreas Ritthaler, 2024/02/19)
level_set);
// As we iterate over the cells, we don't need to do anything on the cells
- // that have FENothing elements. To disregard them we use an iterator
+ // that have FE_Nothing elements. To disregard them we use an iterator
// filter.
for (const auto &cell :
dof_handler.active_cell_iterators() |
const size_type n_local_cols = col_indices.size();
// Early return if the length of row and column indices is zero, relevant
- // for the usage with FENothing.
+ // for the usage with FE_Nothing.
if (n_local_cols == 0 && n_local_rows == 0)
return;
* Return whether an element is supported by MatrixFree.
*
* The following scalar elements are supported:
- * - FENothing, FE_DGP, and FE_Q_DG0
+ * - FE_Nothing, FE_DGP, and FE_Q_DG0
* - polynomial tensor-product elements based on
- * Polynomials::Polynomial (FE_Q, FE_DG_Q, FE_DGQArbitraryNodes,
+ * Polynomials::Polynomial (FE_Q, FE_DGQ, FE_DGQArbitraryNodes,
* FE_DGQHermite, FE_DGQLegendre) or Polynomials::PiecewisePolynomial
* (FE_Q_iso_Q1).
* - elements for simplex, pyramids, and wedges (FE_SimplexP,
/**
* A wrapper around MatrixFree to help users to deal with DoFHandler
* objects involving cells without degrees of freedom, i.e.,
- * cells using FENothing as element type. In the following we call such cells
- * deactivated. All other cells are activated. In contrast to MatrixFree,
- * this class skips deactivated cells and faces between activated and
- * deactivated cells are treated as boundary faces.
+ * cells using FE_Nothing as element type. In the following we call such
+ * cells deactivated. All other cells are activated. In contrast to
+ * MatrixFree, this class skips deactivated cells and faces between activated
+ * and deactivated cells are treated as boundary faces.
*/
template <int dim,
typename Number,
*
* @note At the moment, only DoFHandler objects are accepted
* that are initialized with FECollection objects with at most
- * two finite elements (i.e., `FENothing` and another finite
+ * two finite elements (i.e., `FE_Nothing` and another finite
* element).
*/
void
// Create a mesh with hanging
-// nodes and FEQ/FENothing interfaces
+// nodes and FEQ/FE_Nothing interfaces
// in several admissible configurations
// we'd like to check. In 2D the mesh
// looks like the following (with 0
// Create a mesh with hanging
-// nodes and FEQ/FENothing interfaces
+// nodes and FEQ/FE_Nothing interfaces
// in several admissible configurations
// we'd like to check. In 2D the mesh
// looks like the following.
// test that FE_Nothing works as intended
-// Create a mesh with hanging nodes and FEQ/FENothing interfaces in
+// Create a mesh with hanging nodes and FEQ/FE_Nothing interfaces in
// several admissible configurations we'd like to check. In 2D the
// mesh looks like the following.
//
// check the case where the two children on a face with a hanging node
-// have different FENothing structure:
+// have different FE_Nothing structure:
// active_fe_index
// *-----*--*--*
// check the case where the two children on a face with a hanging node have
-// different FENothing structure. while all cells in the _12 test had degrees
+// different FE_Nothing structure. while all cells in the _12 test had degrees
// of freedom, here, cells with active_fe_index==1 are simply FE_Nothing:
// active_fe_index
// check the case where the two children on a face with a hanging node have
-// different FENothing structure. compared to _12 and _13, the situation is
+// different FE_Nothing structure. compared to _12 and _13, the situation is
// even more wicked since in the picture below 0=FE_Q(1), 1=FE_Nothing,
// 2=FE_Q(2), i.e. 2 dominates 1
// SolutionTransfer got into trouble when interpolating between an old and a
-// new mesh where some cells are set to use FENothing, see bug #83
+// new mesh where some cells are set to use FE_Nothing, see bug #83
// (https://code.google.com/p/dealii/issues/detail?id=83)
//
// the testcase is really invalid -- it forgot to call
// A lightly adapted version of the step-4 tutorial program. Compared
// to step-4, this test uses hp::DoFHandler and
// parallel::distributed::Triangulation. In the upper half of the domain
-// FENothing is used to save effort, as these elements would only be used later.
-// The test checks whether the hanging-node constraints are setup correctly.
+// FE_Nothing is used to save effort, as these elements would only be used
+// later. The test checks whether the hanging-node constraints are setup
+// correctly.
#include <deal.II/base/conditional_ostream.h>
#include <deal.II/base/function.h>