]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Removed hp::DoFHandler. 13808/head
authorMarc Fehling <mafehling.git@gmail.com>
Wed, 25 May 2022 04:07:28 +0000 (22:07 -0600)
committerMarc Fehling <mafehling.git@gmail.com>
Fri, 27 May 2022 17:16:16 +0000 (11:16 -0600)
53 files changed:
doc/news/changes/incompatibilities/20220524FehlingMunch [new file with mode: 0644]
include/deal.II/distributed/solution_transfer.h
include/deal.II/dofs/dof_accessor.h
include/deal.II/dofs/dof_renumbering.h
include/deal.II/dofs/dof_tools.h
include/deal.II/fe/fe.h
include/deal.II/fe/fe_enriched.h
include/deal.II/fe/fe_tools.templates.h
include/deal.II/fe/fe_tools_extrapolate.templates.h
include/deal.II/fe/fe_tools_interpolate.templates.h
include/deal.II/fe/mapping_fe_field.h
include/deal.II/grid/grid_tools.h
include/deal.II/hp/dof_handler.h [deleted file]
include/deal.II/matrix_free/matrix_free.h
include/deal.II/matrix_free/matrix_free.templates.h
include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h
include/deal.II/numerics/data_out.h
include/deal.II/numerics/data_out_dof_data.h
include/deal.II/numerics/data_out_dof_data.templates.h
include/deal.II/numerics/data_out_faces.h
include/deal.II/numerics/data_out_rotation.h
include/deal.II/numerics/data_out_stack.h
include/deal.II/numerics/data_postprocessor.h
include/deal.II/numerics/fe_field_function.h
include/deal.II/numerics/solution_transfer.h
source/distributed/solution_transfer.cc
source/dofs/dof_accessor.cc
source/dofs/dof_accessor_get.cc
source/dofs/dof_accessor_set.cc
source/dofs/dof_renumbering.cc
source/dofs/dof_tools.cc
source/fe/mapping_fe_field.cc
source/grid/grid_tools_dof_handlers.cc
source/numerics/data_out.cc
source/numerics/data_out_stack.cc
source/numerics/fe_field_function.cc
source/numerics/smoothness_estimator.cc
tests/bits/periodicity_06.cc
tests/bits/periodicity_07.cc
tests/data_out/data_out_faces_postprocessor_scalar_02.cc
tests/data_out/data_out_faces_postprocessor_vector_02.cc
tests/data_out/data_out_postprocessor_scalar_02.cc
tests/data_out/data_out_postprocessor_vector_02.cc
tests/data_out/data_out_rotation_postprocessor_scalar_02.cc
tests/dofs/count_dofs_on_patch.cc
tests/dofs/extract_dofs_by_component_02_mg.cc
tests/dofs/get_dofs_on_patch.cc
tests/matrix_free/matrix_vector_hp_no_template.cc
tests/mpi/periodicity_02.cc
tests/mpi/periodicity_03.cc
tests/mpi/periodicity_04.cc
tests/mpi/periodicity_06.cc
tests/mpi/periodicity_07.cc

diff --git a/doc/news/changes/incompatibilities/20220524FehlingMunch b/doc/news/changes/incompatibilities/20220524FehlingMunch
new file mode 100644 (file)
index 0000000..794728b
--- /dev/null
@@ -0,0 +1,8 @@
+Removed: The previously deprecated class hp::DoFHandler has been
+removed, and with it all functions and classes that required the
+template parameter DoFHandlerType.
+<br>
+From now on, use the standard DoFHandler. All hp-functionality has been
+integrated to this one.
+<br>
+(Marc Fehling, Peter Munch, 2022/05/24)
index a2c0e21059c4c70bdcf010c44d5f55cfdfb7b25f..63c822b3b77a2973f14807923345ee3b8c14b7bc 100644 (file)
@@ -366,26 +366,6 @@ namespace parallel
   } // namespace distributed
 } // namespace parallel
 
-namespace Legacy
-{
-  namespace parallel
-  {
-    namespace distributed
-    {
-      /**
-       * @deprecated Use dealii::parallel::distributed::SolutionTransfer
-       * without the DoFHandlerType template instead.
-       */
-      template <int dim,
-                typename VectorType,
-                typename DoFHandlerType = DoFHandler<dim>>
-      using SolutionTransfer DEAL_II_DEPRECATED =
-        dealii::parallel::distributed::
-          SolutionTransfer<dim, VectorType, DoFHandlerType::space_dimension>;
-    } // namespace distributed
-  }   // namespace parallel
-} // namespace Legacy
-
 
 DEAL_II_NAMESPACE_CLOSE
 
index 74f4f3f163f715b2d9f3e9d99cc47524e76f5187..db40f0c235726bc62b5ec513ea48790736a5db37 100644 (file)
@@ -24,8 +24,6 @@
 
 #include <deal.II/grid/tria_accessor.h>
 
-#include <deal.II/hp/dof_handler.h>
-
 DEAL_II_DISABLE_EXTRA_DIAGNOSTICS
 #include <boost/container/small_vector.hpp>
 DEAL_II_ENABLE_EXTRA_DIAGNOSTICS
index 39136671bc81d0b8a94ad66d1e042dd7a491644e..cf376200bba1749464939b0c29944d06eff9a031 100644 (file)
@@ -24,8 +24,6 @@
 
 #include <deal.II/dofs/dof_handler.h>
 
-#include <deal.II/hp/dof_handler.h>
-
 #include <vector>
 
 DEAL_II_NAMESPACE_OPEN
index 5a28833641cde1c3b6dc0099c8277d76f17f0746..47cab54aebd5687193ed0a88143603cda67aa28f 100644 (file)
@@ -27,8 +27,6 @@
 
 #include <deal.II/fe/component_mask.h>
 
-#include <deal.II/hp/dof_handler.h>
-
 #include <deal.II/lac/affine_constraints.h>
 
 #include <map>
@@ -1061,7 +1059,6 @@ namespace DoFTools
     const number periodicity_factor = 1.);
 
 
-
   /**
    * Insert the (algebraic) constraints due to periodic boundary conditions
    * into an AffineConstraints object @p constraints.
@@ -1092,24 +1089,6 @@ namespace DoFTools
       std::vector<unsigned int>(),
     const number periodicity_factor = 1.);
 
-  /**
-   * The same as above.
-   *
-   * @deprecated Use the function that takes dim and spacedim as template
-   *   argument.
-   */
-  template <typename DoFHandlerType, typename number>
-  DEAL_II_DEPRECATED void
-  make_periodicity_constraints(
-    const std::vector<
-      GridTools::PeriodicFacePair<typename DoFHandlerType::cell_iterator>>
-      &                              periodic_faces,
-    AffineConstraints<number> &      constraints,
-    const ComponentMask &            component_mask = ComponentMask(),
-    const std::vector<unsigned int> &first_vector_components =
-      std::vector<unsigned int>(),
-    const number periodicity_factor = 1.);
-
 
 
   /**
@@ -1891,17 +1870,6 @@ namespace DoFTools
     const std::vector<typename DoFHandler<dim, spacedim>::active_cell_iterator>
       &patch);
 
-  /**
-   * The same as above.
-   *
-   * @deprecated Use the function that takes dim and spacedim as template
-   *   argument.
-   */
-  template <typename DoFHandlerType>
-  DEAL_II_DEPRECATED std::vector<types::global_dof_index>
-                     get_dofs_on_patch(
-                       const std::vector<typename DoFHandlerType::active_cell_iterator> &patch);
-
   /**
    * Creates a sparsity pattern, which lists
    * the degrees of freedom associated to each cell on the given
@@ -2206,17 +2174,6 @@ namespace DoFTools
     const std::vector<typename DoFHandler<dim, spacedim>::active_cell_iterator>
       &patch);
 
-  /**
-   * The same as above.
-   *
-   * @deprecated Use the function that takes dim and spacedim as template
-   *   argument.
-   */
-  template <typename DoFHandlerType>
-  DEAL_II_DEPRECATED unsigned int
-  count_dofs_on_patch(
-    const std::vector<typename DoFHandlerType::active_cell_iterator> &patch);
-
   /**
    * @}
    */
@@ -2684,50 +2641,6 @@ namespace DoFTools
     for (types::global_dof_index i = 0; i < dof_handler.n_dofs(); ++i)
       point_to_index_map[support_points[i]] = i;
   }
-
-
-
-  template <typename DoFHandlerType, typename number>
-  inline void
-  make_periodicity_constraints(
-    const std::vector<
-      GridTools::PeriodicFacePair<typename DoFHandlerType::cell_iterator>>
-      &                              periodic_faces,
-    AffineConstraints<number> &      constraints,
-    const ComponentMask &            component_mask,
-    const std::vector<unsigned int> &first_vector_components,
-    const number                     periodicity_factor)
-  {
-    make_periodicity_constraints<DoFHandlerType::dimension,
-                                 DoFHandlerType::space_dimension>(
-      periodic_faces,
-      constraints,
-      component_mask,
-      first_vector_components,
-      periodicity_factor);
-  }
-
-
-
-  template <typename DoFHandlerType>
-  inline std::vector<types::global_dof_index>
-  get_dofs_on_patch(
-    const std::vector<typename DoFHandlerType::active_cell_iterator> &patch)
-  {
-    return get_dofs_on_patch<DoFHandlerType::dimension,
-                             DoFHandlerType::space_dimension>(patch);
-  }
-
-
-
-  template <typename DoFHandlerType>
-  inline unsigned int
-  count_dofs_on_patch(
-    const std::vector<typename DoFHandlerType::active_cell_iterator> &patch)
-  {
-    return count_dofs_on_patch<DoFHandlerType::dimension,
-                               DoFHandlerType::space_dimension>(patch);
-  }
 } // namespace DoFTools
 
 #endif
index 3bd303c1f5d70f3bf856ea103a57475052ff7c33..e0de934c0acc907f3a67a9cc2b89c746de0bf16c 100644 (file)
@@ -826,33 +826,6 @@ public:
   virtual std::string
   get_name() const = 0;
 
-  /**
-   * This operator returns a reference to the present object if the argument
-   * given equals to zero. While this does not seem particularly useful, it is
-   * helpful in writing code that works with both ::DoFHandler and the hp-
-   * version hp::DoFHandler, since one can then write code like this:
-   * @code
-   * dofs_per_cell =
-   *   dof_handler->get_fe()[cell->active_fe_index()].n_dofs_per_cell();
-   * @endcode
-   *
-   * This code doesn't work in both situations without the present operator
-   * because DoFHandler::get_fe() returns a finite element, whereas
-   * hp::DoFHandler::get_fe() returns a collection of finite elements that
-   * doesn't offer a <code>dofs_per_cell</code> member variable: one first has
-   * to select which finite element to work on, which is done using the
-   * operator[]. Fortunately, <code>cell-@>active_fe_index()</code> also works
-   * for non-hp-classes and simply returns zero in that case. The present
-   * operator[] accepts this zero argument, by returning the finite element
-   * with index zero within its collection (that, of course, consists only of
-   * the present finite element anyway).
-   *
-   * @deprecated With DoFHandler::get_fe(int) and the deprecation of the
-   * hp::DoFHandler class, there is no more use of this operator.
-   */
-  DEAL_II_DEPRECATED const FiniteElement<dim, spacedim> &
-                           operator[](const unsigned int fe_index) const;
-
   /**
    * @name Shape function access
    * @{
@@ -3093,18 +3066,6 @@ protected:
 //----------------------------------------------------------------------//
 
 
-template <int dim, int spacedim>
-inline const FiniteElement<dim, spacedim> &
-FiniteElement<dim, spacedim>::operator[](const unsigned int fe_index) const
-{
-  (void)fe_index;
-  Assert(fe_index == 0,
-         ExcMessage("A fe_index of zero is the only index allowed here"));
-  return *this;
-}
-
-
-
 template <int dim, int spacedim>
 inline std::pair<unsigned int, unsigned int>
 FiniteElement<dim, spacedim>::system_to_component_index(
index de7c119139c2cd1a82f5167ebcfe2ede0d1f861f..65bb51fe96b94d4731a47c32a5b832c740ba2f40 100644 (file)
 #include <deal.II/base/quadrature.h>
 #include <deal.II/base/symmetric_tensor.h>
 
+#include <deal.II/dofs/dof_handler.h>
+
 #include <deal.II/fe/fe.h>
 #include <deal.II/fe/fe_nothing.h>
 #include <deal.II/fe/fe_q.h>
 #include <deal.II/fe/fe_system.h>
 #include <deal.II/fe/fe_update_flags.h>
 
-#include <deal.II/hp/dof_handler.h>
 #include <deal.II/hp/fe_collection.h>
 
 #include <map>
index c8f7678dc66a90aeb10b26a35d16a69257455bfd..74b524a2dde685d2369dbcc5168b4876b231f4a4 100644 (file)
@@ -60,8 +60,6 @@
 #include <deal.II/grid/tria.h>
 #include <deal.II/grid/tria_iterator.h>
 
-#include <deal.II/hp/dof_handler.h>
-
 #include <deal.II/lac/full_matrix.h>
 #include <deal.II/lac/householder.h>
 
index 7106bb5b1eea19f966a10e1f3961a835426a03b9..7275bec5a7fd98a8957f5ba27f7f5cf724af9519 100644 (file)
@@ -1761,10 +1761,10 @@ namespace FETools
     if (dynamic_cast<const parallel::distributed::Triangulation<dim, spacedim>
                        *>(&dof2.get_triangulation()) != nullptr)
       {
-        Assert(dof1.get_fe()[0].reference_cell() ==
+        Assert(dof1.get_fe(0).reference_cell() ==
                  ReferenceCells::get_hypercube<dim>(),
                ExcNotImplemented());
-        Assert(dof2.get_fe()[0].reference_cell() ==
+        Assert(dof2.get_fe(0).reference_cell() ==
                  ReferenceCells::get_hypercube<dim>(),
                ExcNotImplemented());
 
index 3afa943dafb9fbc98089e56f18c81b55a9f25bd9..b5e6c7ff9217a03c613e2a5a24d9d4b1f8761724 100644 (file)
@@ -36,8 +36,6 @@
 #include <deal.II/grid/tria.h>
 #include <deal.II/grid/tria_iterator.h>
 
-#include <deal.II/hp/dof_handler.h>
-
 #include <deal.II/lac/affine_constraints.h>
 #include <deal.II/lac/block_vector.h>
 #include <deal.II/lac/la_parallel_block_vector.h>
index 4809b1b68f3d3e4c3b6275701586ac85f5149867..1db832688e3f7848e55b3109a07bd8438400d96b 100644 (file)
@@ -39,56 +39,6 @@ DEAL_II_NAMESPACE_OPEN
 /*!@addtogroup mapping */
 /*@{*/
 
-/**
- * @deprecated Use MappingFEField<dim, spacedim, VectorType> instead.
- */
-template <int dim,
-          int spacedim            = dim,
-          typename VectorType     = Vector<double>,
-          typename DoFHandlerType = void>
-class MappingFEField;
-
-#ifndef DOXYGEN
-// prevent doxygen from complaining about potential recursive class relations
-template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
-class MappingFEField : public MappingFEField<dim, spacedim, VectorType, void>
-{
-public:
-  DEAL_II_DEPRECATED
-  MappingFEField(const DoFHandlerType &euler_dof_handler,
-                 const VectorType &    euler_vector,
-                 const ComponentMask & mask = ComponentMask())
-    : MappingFEField<dim, spacedim, VectorType, void>(euler_dof_handler,
-                                                      euler_vector,
-                                                      mask)
-  {}
-
-  DEAL_II_DEPRECATED
-  MappingFEField(const DoFHandlerType &         euler_dof_handler,
-                 const std::vector<VectorType> &euler_vector,
-                 const ComponentMask &          mask = ComponentMask())
-    : MappingFEField<dim, spacedim, VectorType, void>(euler_dof_handler,
-                                                      euler_vector,
-                                                      mask)
-  {}
-
-  DEAL_II_DEPRECATED
-  MappingFEField(const DoFHandlerType &           euler_dof_handler,
-                 const MGLevelObject<VectorType> &euler_vector,
-                 const ComponentMask &            mask = ComponentMask())
-    : MappingFEField<dim, spacedim, VectorType, void>(euler_dof_handler,
-                                                      euler_vector,
-                                                      mask)
-  {}
-
-  DEAL_II_DEPRECATED
-  MappingFEField(
-    const MappingFEField<dim, spacedim, VectorType, DoFHandlerType> &mapping)
-    : MappingFEField<dim, spacedim, VectorType, void>(mapping)
-  {}
-};
-#endif // DOXYGEN
-
 /**
  * The MappingFEField is a generalization of the MappingQEulerian class, for
  * arbitrary vector finite elements. The two main differences are that this
@@ -124,9 +74,8 @@ public:
  *    MappingFEField<dim,spacedim> map(dhq, eulerq, mask);
  * @endcode
  */
-template <int dim, int spacedim, typename VectorType>
-class MappingFEField<dim, spacedim, VectorType, void>
-  : public Mapping<dim, spacedim>
+template <int dim, int spacedim = dim, typename VectorType = Vector<double>>
+class MappingFEField : public Mapping<dim, spacedim>
 {
 public:
   /**
@@ -192,8 +141,7 @@ public:
   /**
    * Copy constructor.
    */
-  MappingFEField(
-    const MappingFEField<dim, spacedim, VectorType, void> &mapping);
+  MappingFEField(const MappingFEField<dim, spacedim, VectorType> &mapping);
 
   /**
    * Return a pointer to a copy of the present object. The caller of this copy
@@ -603,15 +551,15 @@ protected:
   /**
    * Reference to the vector of shifts.
    */
-  std::vector<SmartPointer<const VectorType,
-                           MappingFEField<dim, spacedim, VectorType, void>>>
+  std::vector<
+    SmartPointer<const VectorType, MappingFEField<dim, spacedim, VectorType>>>
     euler_vector;
 
   /**
    * Pointer to the DoFHandler to which the mapping vector is associated.
    */
   SmartPointer<const DoFHandler<dim, spacedim>,
-               MappingFEField<dim, spacedim, VectorType, void>>
+               MappingFEField<dim, spacedim, VectorType>>
     euler_dof_handler;
 
 private:
@@ -661,7 +609,7 @@ private:
   void
   update_internal_dofs(
     const typename Triangulation<dim, spacedim>::cell_iterator &cell,
-    const typename MappingFEField<dim, spacedim, VectorType, void>::InternalData
+    const typename MappingFEField<dim, spacedim, VectorType>::InternalData
       &data) const;
 
   /**
@@ -670,8 +618,8 @@ private:
   virtual void
   compute_shapes_virtual(
     const std::vector<Point<dim>> &unit_points,
-    typename MappingFEField<dim, spacedim, VectorType, void>::InternalData
-      &data) const;
+    typename MappingFEField<dim, spacedim, VectorType>::InternalData &data)
+    const;
 
   /*
    * Which components to use for the mapping.
@@ -714,7 +662,7 @@ private:
 
 
   // Declare other MappingFEField classes friends.
-  template <int, int, class, class>
+  template <int, int, class>
   friend class MappingFEField;
 };
 
index f3f85b5ee95ac6c1d7fe9ae94f1891e1900d59ba..ec7008cb9ebcc454d7f55a4e287d68de74e3e618 100644 (file)
@@ -39,8 +39,6 @@
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
 
-#include <deal.II/hp/dof_handler.h>
-
 #include <deal.II/lac/la_parallel_vector.h>
 #include <deal.II/lac/la_vector.h>
 #include <deal.II/lac/petsc_vector.h>
diff --git a/include/deal.II/hp/dof_handler.h b/include/deal.II/hp/dof_handler.h
deleted file mode 100644 (file)
index bb49a9b..0000000
+++ /dev/null
@@ -1,129 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2005 - 2021 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE.md at
-// the top level directory of deal.II.
-//
-// ---------------------------------------------------------------------
-
-#ifndef dealii_hp_dof_handler_h
-#define dealii_hp_dof_handler_h
-
-#include <deal.II/dofs/dof_handler.h>
-
-DEAL_II_NAMESPACE_OPEN
-
-namespace hp
-{
-  /**
-   * Manage the distribution and numbering of the degrees of freedom for hp-
-   * FEM algorithms. This class satisfies the
-   * @ref ConceptMeshType "MeshType concept"
-   * requirements.
-   *
-   * The purpose of this class is to allow for an enumeration of degrees of
-   * freedom in the same way as the ::DoFHandler class, but it allows to use a
-   * different finite element on every cell. To this end, one assigns an
-   * <code>active_fe_index</code> to every cell that indicates which element
-   * within a collection of finite elements (represented by an object of type
-   * hp::FECollection) is the one that lives on this cell. The class then
-   * enumerates the degree of freedom associated with these finite elements on
-   * each cell of a triangulation and, if possible, identifies degrees of
-   * freedom at the interfaces of cells if they match. If neighboring cells
-   * have degrees of freedom along the common interface that do not immediate
-   * match (for example, if you have $Q_2$ and $Q_3$ elements meeting at a
-   * common face), then one needs to compute constraints to ensure that the
-   * resulting finite element space on the mesh remains conforming.
-   *
-   * The whole process of working with objects of this type is explained in
-   * step-27. Many of the algorithms this class implements are described in
-   * the
-   * @ref hp_paper "hp-paper".
-   *
-   *
-   * <h3>Active FE indices and their behavior under mesh refinement</h3>
-   *
-   * The typical workflow for using this class is to create a mesh, assign an
-   * active FE index to every active cell, calls
-   * hp::DoFHandler::distribute_dofs(), and then assemble a linear system and
-   * solve a problem on this finite element space. However, one can skip
-   * assigning active FE indices upon mesh refinement in certain
-   * circumstances. In particular, the following rules apply:
-   * - Upon mesh refinement, child cells inherit the active FE index of
-   *   the parent.
-   * - When coarsening cells, the (now active) parent cell will be assigned
-   *   an active FE index that is determined from its (no longer active)
-   *   children, following the FiniteElementDomination logic: Out of the set of
-   *   elements previously assigned to the former children, we choose the one
-   *   dominated by all children for the parent cell. If none was found, we pick
-   *   the most dominant element in the whole collection that is dominated by
-   *   all former children. See hp::FECollection::find_dominated_fe_extended()
-   *   for further information on this topic.
-   *
-   * @note Finite elements need to be assigned to each cell by either calling
-   * set_fe() or distribute_dofs() first to make this functionality available.
-   *
-   *
-   * <h3>Active FE indices and parallel meshes</h3>
-   *
-   * When this class is used with either a parallel::shared::Triangulation
-   * or a parallel::distributed::Triangulation, you can only set active
-   * FE indices on cells that are locally owned,
-   * using a call such as <code>cell-@>set_active_fe_index(...)</code>.
-   * On the other hand, setting the active FE index on ghost
-   * or artificial cells is not allowed.
-   *
-   * Ghost cells do acquire the information what element
-   * is active on them, however: whenever
-   * you call hp::DoFHandler::distribute_dofs(), all processors that
-   * participate in the parallel mesh exchange information in such a way
-   * that the active FE index on ghost cells equals the active FE index
-   * that was set on that processor that owned that particular ghost cell.
-   * Consequently, one can <i>query</i> the @p active_fe_index on ghost
-   * cells, just not set it by hand.
-   *
-   * On artificial cells, no information is available about the
-   * @p active_fe_index used there. That's because we don't even know
-   * whether these cells exist at all, and even if they did, the
-   * current processor does not know anything specific about them.
-   * See
-   * @ref GlossArtificialCell "the glossary entry on artificial cells"
-   * for more information.
-   *
-   * During refinement and coarsening, information about the @p active_fe_index
-   * of each cell will be automatically transferred.
-   *
-   * However, using a parallel::distributed::Triangulation with an
-   * hp::DoFHandler requires additional attention during serialization, since no
-   * information on active FE indices will be automatically transferred. This
-   * has to be done manually using the
-   * prepare_for_serialization_of_active_fe_indices() and
-   * deserialize_active_fe_indices() functions. The former has to be called
-   * before parallel::distributed::Triangulation::save() is invoked, and the
-   * latter needs to be run after parallel::distributed::Triangulation::load().
-   * If further data will be attached to the triangulation via the
-   * parallel::distributed::CellDataTransfer,
-   * parallel::distributed::SolutionTransfer, or Particles::ParticleHandler
-   * classes, all corresponding preparation and deserialization function calls
-   * need to happen in the same order. Consult the documentation of
-   * parallel::distributed::SolutionTransfer for more information.
-   *
-   *
-   * @ingroup dofs
-   *
-   * @deprecated The basic dealii::DoFHandler is capable of hp-adaptation now.
-   */
-  template <int dim, int spacedim = dim>
-  using DoFHandler DEAL_II_DEPRECATED = dealii::DoFHandler<dim, spacedim>;
-} // namespace hp
-
-DEAL_II_NAMESPACE_CLOSE
-
-#endif
index 498d0e828e9402462a8976deba994317a20ff8ec..403954a29b28b8a8a2757cecf9d0c997920a4122 100644 (file)
@@ -32,7 +32,6 @@
 #include <deal.II/fe/mapping.h>
 #include <deal.II/fe/mapping_q1.h>
 
-#include <deal.II/hp/dof_handler.h>
 #include <deal.II/hp/mapping_collection.h>
 #include <deal.II/hp/q_collection.h>
 
@@ -623,22 +622,6 @@ public:
          const std::vector<QuadratureType> &                    quad,
          const AdditionalData &additional_data = AdditionalData());
 
-  /**
-   * Initializes the data structures. Same as above, but  using DoFHandlerType.
-   *
-   * @deprecated Use the overload taking a DoFHandler object instead.
-   */
-  template <typename QuadratureType,
-            typename number2,
-            typename DoFHandlerType,
-            typename MappingType>
-  DEAL_II_DEPRECATED void
-  reinit(const MappingType &                                    mapping,
-         const std::vector<const DoFHandlerType *> &            dof_handler,
-         const std::vector<const AffineConstraints<number2> *> &constraint,
-         const std::vector<QuadratureType> &                    quad,
-         const AdditionalData &additional_data = AdditionalData());
-
   /**
    * Initializes the data structures. Same as above, but  using a $Q_1$
    * mapping.
@@ -652,18 +635,6 @@ public:
          const std::vector<QuadratureType> &                    quad,
          const AdditionalData &additional_data = AdditionalData());
 
-  /**
-   * Initializes the data structures. Same as above, but  using DoFHandlerType.
-   *
-   * @deprecated Use the overload taking a DoFHandler object instead.
-   */
-  template <typename QuadratureType, typename number2, typename DoFHandlerType>
-  DEAL_II_DEPRECATED void
-  reinit(const std::vector<const DoFHandlerType *> &            dof_handler,
-         const std::vector<const AffineConstraints<number2> *> &constraint,
-         const std::vector<QuadratureType> &                    quad,
-         const AdditionalData &additional_data = AdditionalData());
-
   /**
    * Initializes the data structures. Same as before, but now the index set
    * description of the locally owned range of degrees of freedom is taken
@@ -679,22 +650,6 @@ public:
          const QuadratureType &                                 quad,
          const AdditionalData &additional_data = AdditionalData());
 
-  /**
-   * Initializes the data structures. Same as above, but  using DoFHandlerType.
-   *
-   * @deprecated Use the overload taking a DoFHandler object instead.
-   */
-  template <typename QuadratureType,
-            typename number2,
-            typename DoFHandlerType,
-            typename MappingType>
-  DEAL_II_DEPRECATED void
-  reinit(const MappingType &                                    mapping,
-         const std::vector<const DoFHandlerType *> &            dof_handler,
-         const std::vector<const AffineConstraints<number2> *> &constraint,
-         const QuadratureType &                                 quad,
-         const AdditionalData &additional_data = AdditionalData());
-
   /**
    * Initializes the data structures. Same as above, but  using a $Q_1$
    * mapping.
@@ -708,18 +663,6 @@ public:
          const QuadratureType &                                 quad,
          const AdditionalData &additional_data = AdditionalData());
 
-  /**
-   * Initializes the data structures. Same as above, but  using DoFHandlerType.
-   *
-   * @deprecated Use the overload taking a DoFHandler object instead.
-   */
-  template <typename QuadratureType, typename number2, typename DoFHandlerType>
-  DEAL_II_DEPRECATED void
-  reinit(const std::vector<const DoFHandlerType *> &            dof_handler,
-         const std::vector<const AffineConstraints<number2> *> &constraint,
-         const QuadratureType &                                 quad,
-         const AdditionalData &additional_data = AdditionalData());
-
   /**
    * Copy function. Creates a deep copy of all data structures. It is usually
    * enough to keep the data for different operations once, so this function
@@ -1727,20 +1670,6 @@ public:
   const DoFHandler<dim> &
   get_dof_handler(const unsigned int dof_handler_index = 0) const;
 
-  /**
-   * Return the DoFHandler with the index as given to the respective
-   * `std::vector` argument in the reinit() function. Note that if you want to
-   * call this function with a template parameter different than the default
-   * one, you will need to use the `template` before the function call, i.e.,
-   * you will have something like `matrix_free.template
-   * get_dof_handler<hp::DoFHandler<dim>>()`.
-   *
-   * @deprecated Use the non-templated equivalent of this function.
-   */
-  template <typename DoFHandlerType>
-  DEAL_II_DEPRECATED const DoFHandlerType &
-  get_dof_handler(const unsigned int dof_handler_index = 0) const;
-
   /**
    * Return the cell iterator in deal.II speak to a given cell batch
    * (populating several lanes in a VectorizedArray) and the lane index within
@@ -3119,32 +3048,6 @@ MatrixFree<dim, Number, VectorizedArrayType>::reinit(
 
 
 
-template <int dim, typename Number, typename VectorizedArrayType>
-template <typename QuadratureType,
-          typename number2,
-          typename DoFHandlerType,
-          typename MappingType>
-void
-MatrixFree<dim, Number, VectorizedArrayType>::reinit(
-  const MappingType &                                    mapping,
-  const std::vector<const DoFHandlerType *> &            dof_handler,
-  const std::vector<const AffineConstraints<number2> *> &constraint,
-  const std::vector<QuadratureType> &                    quad,
-  const AdditionalData &                                 additional_data)
-{
-  static_assert(dim == DoFHandlerType::dimension,
-                "Dimension dim not equal to DoFHandlerType::dimension.");
-
-  std::vector<const DoFHandler<dim> *> dof_handlers;
-
-  for (const auto dh : dof_handler)
-    dof_handlers.push_back(dh);
-
-  this->reinit(mapping, dof_handlers, constraint, quad, additional_data);
-}
-
-
-
 template <int dim, typename Number, typename VectorizedArrayType>
 template <typename QuadratureType, typename number2>
 void
@@ -3172,28 +3075,6 @@ MatrixFree<dim, Number, VectorizedArrayType>::reinit(
 
 
 
-template <int dim, typename Number, typename VectorizedArrayType>
-template <typename QuadratureType, typename number2, typename DoFHandlerType>
-void
-MatrixFree<dim, Number, VectorizedArrayType>::reinit(
-  const std::vector<const DoFHandlerType *> &            dof_handler,
-  const std::vector<const AffineConstraints<number2> *> &constraint,
-  const std::vector<QuadratureType> &                    quad,
-  const AdditionalData &                                 additional_data)
-{
-  static_assert(dim == DoFHandlerType::dimension,
-                "Dimension dim not equal to DoFHandlerType::dimension.");
-
-  std::vector<const DoFHandler<dim> *> dof_handlers;
-
-  for (const auto dh : dof_handler)
-    dof_handlers.push_back(dh);
-
-  this->reinit(dof_handlers, constraint, quad, additional_data);
-}
-
-
-
 template <int dim, typename Number, typename VectorizedArrayType>
 template <typename QuadratureType, typename number2, typename MappingType>
 void
@@ -3249,54 +3130,6 @@ MatrixFree<dim, Number, VectorizedArrayType>::reinit(
 
 
 
-template <int dim, typename Number, typename VectorizedArrayType>
-template <typename QuadratureType,
-          typename number2,
-          typename DoFHandlerType,
-          typename MappingType>
-void
-MatrixFree<dim, Number, VectorizedArrayType>::reinit(
-  const MappingType &                                    mapping,
-  const std::vector<const DoFHandlerType *> &            dof_handler,
-  const std::vector<const AffineConstraints<number2> *> &constraint,
-  const QuadratureType &                                 quad,
-  const AdditionalData &                                 additional_data)
-{
-  static_assert(dim == DoFHandlerType::dimension,
-                "Dimension dim not equal to DoFHandlerType::dimension.");
-
-  std::vector<const DoFHandler<dim> *> dof_handlers;
-
-  for (const auto dh : dof_handler)
-    dof_handlers.push_back(dh);
-
-  this->reinit(mapping, dof_handlers, constraint, quad, additional_data);
-}
-
-
-
-template <int dim, typename Number, typename VectorizedArrayType>
-template <typename QuadratureType, typename number2, typename DoFHandlerType>
-void
-MatrixFree<dim, Number, VectorizedArrayType>::reinit(
-  const std::vector<const DoFHandlerType *> &            dof_handler,
-  const std::vector<const AffineConstraints<number2> *> &constraint,
-  const QuadratureType &                                 quad,
-  const AdditionalData &                                 additional_data)
-{
-  static_assert(dim == DoFHandlerType::dimension,
-                "Dimension dim not equal to DoFHandlerType::dimension.");
-
-  std::vector<const DoFHandler<dim> *> dof_handlers;
-
-  for (const auto dh : dof_handler)
-    dof_handlers.push_back(dh);
-
-  this->reinit(dof_handlers, constraint, quad, additional_data);
-}
-
-
-
 // ------------------------------ implementation of loops --------------------
 
 // internal helper functions that define how to call MPI data exchange
index e6adbab2b07fc04a95c350e7884123e5b85c3fa2..e81690a01c845d299332c70d3eb8f2a9f4300173 100644 (file)
@@ -226,23 +226,6 @@ MatrixFree<dim, Number, VectorizedArrayType>::get_dof_handler(
 
 
 
-template <int dim, typename Number, typename VectorizedArrayType>
-template <typename DoFHandlerType>
-const DoFHandlerType &
-MatrixFree<dim, Number, VectorizedArrayType>::get_dof_handler(
-  const unsigned int dof_handler_index) const
-{
-  AssertIndexRange(dof_handler_index, n_components());
-
-  auto dh =
-    dynamic_cast<const DoFHandlerType *>(&*dof_handlers[dof_handler_index]);
-  Assert(dh != nullptr, ExcNotInitialized());
-
-  return *dh;
-}
-
-
-
 template <int dim, typename Number, typename VectorizedArrayType>
 typename DoFHandler<dim>::cell_iterator
 MatrixFree<dim, Number, VectorizedArrayType>::get_cell_iterator(
index c068e3d97beb957d37dd658cca7301bc51b02009..8015df751b6b9b9ea41057981a85c71f184d19b7 100644 (file)
@@ -36,8 +36,6 @@
 #include <deal.II/grid/filtered_iterator.h>
 #include <deal.II/grid/tria_description.h>
 
-#include <deal.II/hp/dof_handler.h>
-
 #include <deal.II/matrix_free/evaluation_kernels.h>
 #include <deal.II/matrix_free/evaluation_template_factory.h>
 #include <deal.II/matrix_free/tensor_product_kernels.h>
index 0913e4c7403bbdeebf52537d63541ab7eab1d98e..4dd9e75449a19563d6af8d76fd20cea0b7c282e4 100644 (file)
@@ -451,17 +451,6 @@ private:
     const CurvedCellRegion curved_cell_region);
 };
 
-namespace Legacy
-{
-  /**
-   * @deprecated Use dealii::DataOut without the DoFHandlerType template
-   * instead.
-   */
-  template <int dim, typename DoFHandlerType = DoFHandler<dim>>
-  using DataOut DEAL_II_DEPRECATED =
-    dealii::DataOut<dim, DoFHandlerType::space_dimension>;
-} // namespace Legacy
-
 
 DEAL_II_NAMESPACE_CLOSE
 
index 38d1479175d6899ffd59eed726ed11e683257749..227c8aaca7964f88aaa11485e8519185383aea04 100644 (file)
@@ -928,18 +928,6 @@ public:
     const DataOut_DoFData<dim2, patch_dim, spacedim2, patch_spacedim> &source,
     const Point<patch_spacedim> &shift = Point<patch_spacedim>());
 
-  /**
-   * @deprecated Use merge_patches() without the DoFHandlerType2 template
-   * instead.
-   */
-  template <typename DoFHandlerType2>
-  DEAL_II_DEPRECATED void
-  merge_patches(const DataOut_DoFData<DoFHandlerType2::dimension,
-                                      patch_dim,
-                                      DoFHandlerType2::space_dimension,
-                                      patch_spacedim> &source,
-                const Point<patch_spacedim> &shift = Point<patch_spacedim>());
-
   /**
    * Release the pointers to the data vectors and the DoF handler. You have to
    * set all data entries again using the add_data_vector() function. The
@@ -1239,40 +1227,6 @@ DataOut_DoFData<dim, patch_dim, spacedim, patch_spacedim>::merge_patches(
 }
 
 
-
-template <int dim, int patch_dim, int spacedim, int patch_spacedim>
-template <typename DoFHandlerType2>
-void
-DataOut_DoFData<dim, patch_dim, spacedim, patch_spacedim>::merge_patches(
-  const DataOut_DoFData<DoFHandlerType2::dimension,
-                        patch_dim,
-                        DoFHandlerType2::space_dimension,
-                        patch_spacedim> &source,
-  const Point<patch_spacedim> &          shift)
-{
-  this->merge_patches<DoFHandlerType2::dimension,
-                      DoFHandlerType2::space_dimension>(source, shift);
-}
-
-
-
-namespace Legacy
-{
-  /**
-   * @deprecated Use dealii::DataOut_DoFData without the DoFHandlerType
-   * template instead.
-   */
-  template <typename DoFHandlerType,
-            int patch_dim,
-            int patch_space_dim = patch_dim>
-  using DataOut_DoFData DEAL_II_DEPRECATED =
-    dealii::DataOut_DoFData<DoFHandlerType::dimension,
-                            patch_dim,
-                            DoFHandlerType::space_dimension,
-                            patch_space_dim>;
-} // namespace Legacy
-
-
 DEAL_II_NAMESPACE_CLOSE
 
 #endif
index 29fee5604c065a10d01bfea9341b547f0e782ca3..1f0d657ea933fa7b17e0bafae6cbfde166e839f4 100644 (file)
@@ -40,7 +40,6 @@
 #include <deal.II/grid/tria.h>
 #include <deal.II/grid/tria_iterator.h>
 
-#include <deal.II/hp/dof_handler.h>
 #include <deal.II/hp/fe_collection.h>
 #include <deal.II/hp/fe_values.h>
 #include <deal.II/hp/q_collection.h>
index e45b93e7a8346592084267a609bc171434f94be9..9b9ecb8475a6666a64f52210f019fbf745ad6350 100644 (file)
@@ -243,17 +243,6 @@ private:
     DataOutBase::Patch<patch_dim, patch_spacedim> &                    patch);
 };
 
-namespace Legacy
-{
-  /**
-   * @deprecated Use dealii::DataOutFaces without the DoFHandlerType template
-   * instead.
-   */
-  template <int dim, typename DoFHandlerType = DoFHandler<dim>>
-  using DataOutFaces DEAL_II_DEPRECATED =
-    dealii::DataOutFaces<dim, DoFHandlerType::space_dimension>;
-} // namespace Legacy
-
 
 DEAL_II_NAMESPACE_CLOSE
 
index 7890a43151daf8f52039ed0a0b1235c71bb4298b..ac335fba471ca56e302cab0673c7615e8976fe0d 100644 (file)
@@ -202,17 +202,6 @@ private:
     std::vector<DataOutBase::Patch<patch_dim, patch_spacedim>> &my_patches);
 };
 
-namespace Legacy
-{
-  /**
-   * @deprecated Use dealii::DataOutRotation without the DoFHandlerType
-   * template instead.
-   */
-  template <int dim, typename DoFHandlerType = DoFHandler<dim>>
-  using DataOutRotation DEAL_II_DEPRECATED =
-    dealii::DataOutRotation<dim, DoFHandlerType::space_dimension>;
-} // namespace Legacy
-
 
 DEAL_II_NAMESPACE_CLOSE
 
index 83e086a24ee3e2aa5845d5f40e02e8f8488f7c27..cc1c5c2a50c8282b8b9c822eeb2f10d97f3ff037 100644 (file)
@@ -37,25 +37,6 @@ template <int dim, int spacedim>
 class DoFHandler;
 #endif
 
-/**
- * @deprecated Use DataOutStack<dim, spacedim> instead.
- */
-template <int dim, int spacedim = dim, typename DoFHandlerType = void>
-class DataOutStack;
-
-#ifndef DOXYGEN
-// prevent doxygen from complaining about potential recursive class relations
-template <int dim, int spacedim, typename DoFHandlerType>
-class DataOutStack : public DataOutStack<dim, spacedim, void>
-{
-public:
-  DEAL_II_DEPRECATED
-  DataOutStack()
-    : DataOutStack<dim, spacedim, void>()
-  {}
-};
-#endif // DOXYGEN
-
 /**
  * This class is used to stack the output from several computations into one
  * output file by stacking the data sets in another coordinate direction
@@ -130,9 +111,8 @@ public:
  *
  * @ingroup output
  */
-template <int dim, int spacedim>
-class DataOutStack<dim, spacedim, void>
-  : public DataOutInterface<dim + 1, spacedim + 1>
+template <int dim, int spacedim = dim>
+class DataOutStack : public DataOutInterface<dim + 1, spacedim + 1>
 {
   static_assert(dim < 3,
                 "Because this class stacks data into the (dim+1)st "
@@ -343,8 +323,7 @@ private:
    * DoF handler to be used for the data corresponding to the present
    * parameter value.
    */
-  SmartPointer<const DoFHandler<dim, spacedim>,
-               DataOutStack<dim, spacedim, void>>
+  SmartPointer<const DoFHandler<dim, spacedim>, DataOutStack<dim, spacedim>>
     dof_handler;
 
   /**
@@ -391,9 +370,9 @@ private:
    * data in the form of Patch structures (declared in the base class
    * DataOutBase) to the actual output function.
    */
-  virtual const std::vector<dealii::DataOutBase::Patch<
-    DataOutStack<dim, spacedim, void>::patch_dim,
-    DataOutStack<dim, spacedim, void>::patch_spacedim>> &
+  virtual const std::vector<
+    dealii::DataOutBase::Patch<DataOutStack<dim, spacedim>::patch_dim,
+                               DataOutStack<dim, spacedim>::patch_spacedim>> &
   get_patches() const override;
 
 
index 86dc109d3494b900730259d616ff3f33f8e1733d..ea67c6f89a77566d4c0d83d95bc086eae09dfeec 100644 (file)
@@ -257,21 +257,6 @@ namespace DataPostprocessorInputs
       const typename DoFHandler<dim, spacedim>::cell_iterator &cell,
       const unsigned int                                       face_number);
 
-    /**
-     * Set the cell that is currently being used in evaluating the data
-     * for which the DataPostprocessor object is being called.
-     *
-     * This function is not usually called from user space, but is instead
-     * called by DataOut and similar classes when creating the object that
-     * is then passed to DataPostprocessor.
-     *
-     * @deprecated Use the equivalent function with the dim template parameter
-     * instead.
-     */
-    template <typename DoFHandlerType>
-    DEAL_II_DEPRECATED void
-    set_cell(const typename DoFHandlerType::cell_iterator &cell);
-
     /**
      * Query the cell on which we currently produce graphical output.
      * See the documentation of the current class for an example on how
@@ -281,18 +266,6 @@ namespace DataPostprocessorInputs
     typename DoFHandler<dim, spacedim>::cell_iterator
     get_cell() const;
 
-    /**
-     * Query the cell on which we currently produce graphical output.
-     * See the documentation of the current class for an example on how
-     * to use this function.
-     *
-     * @deprecated Use the equivalent function with the dim template parameter
-     * instead.
-     */
-    template <typename DoFHandlerType>
-    DEAL_II_DEPRECATED typename DoFHandlerType::cell_iterator
-    get_cell() const;
-
     /**
      * Query the face number on which we currently produce graphical output.
      * See the documentation of the current class for an example on how
@@ -1330,17 +1303,6 @@ namespace DataPostprocessors
 
 namespace DataPostprocessorInputs
 {
-  template <int spacedim>
-  template <typename DoFHandlerType>
-  void
-  CommonInputs<spacedim>::set_cell(
-    const typename DoFHandlerType::cell_iterator &new_cell)
-  {
-    return set_cell<DoFHandlerType::dimension>(new_cell);
-  }
-
-
-
   template <int spacedim>
   template <int dim>
   void
@@ -1379,16 +1341,6 @@ namespace DataPostprocessorInputs
 
 
 
-  template <int spacedim>
-  template <typename DoFHandlerType>
-  typename DoFHandlerType::cell_iterator
-  CommonInputs<spacedim>::get_cell() const
-  {
-    return get_cell<DoFHandlerType::dimension>();
-  }
-
-
-
   template <int spacedim>
   template <int dim>
   typename DoFHandler<dim, spacedim>::cell_iterator
index ce4440d70a01849786d4bc1a59c54ff251233ac9..0ff95d47733b6ef42779a7b2a547a9caa61f5bd5 100644 (file)
@@ -488,22 +488,6 @@ namespace Functions
   };
 } // namespace Functions
 
-namespace Legacy
-{
-  namespace Functions
-  {
-    /**
-     * @deprecated Use dealii::Functions::FEFieldFunction without the
-     * DoFHandlerType template instead.
-     */
-    template <int dim,
-              typename DoFHandlerType = DoFHandler<dim>,
-              typename VectorType     = Vector<double>>
-    using FEFieldFunction DEAL_II_DEPRECATED = dealii::Functions::
-      FEFieldFunction<dim, VectorType, DoFHandlerType::space_dimension>;
-  } // namespace Functions
-} // namespace Legacy
-
 
 DEAL_II_NAMESPACE_CLOSE
 
index 470400f7fd578f4d5134fb54a1ba0673c34ccd95..661f9d125814cdd93fddad7f6f9378a7786a0932 100644 (file)
@@ -566,19 +566,6 @@ private:
     dof_values_on_cell;
 };
 
-namespace Legacy
-{
-  /**
-   * @deprecated Use dealii::SolutionTransfer without the DoFHandlerType
-   * template instead.
-   */
-  template <int dim,
-            typename VectorType     = Vector<double>,
-            typename DoFHandlerType = DoFHandler<dim>>
-  using SolutionTransfer DEAL_II_DEPRECATED =
-    dealii::SolutionTransfer<dim, VectorType, DoFHandlerType::space_dimension>;
-} // namespace Legacy
-
 
 DEAL_II_NAMESPACE_CLOSE
 
index 2d10a6e2d2efba3ef5c96e3c6dc175741e7579ff..d617fae5539f299e26ffaef8164db3139fe37313 100644 (file)
@@ -27,8 +27,6 @@
 #  include <deal.II/grid/tria_accessor.h>
 #  include <deal.II/grid/tria_iterator.h>
 
-#  include <deal.II/hp/dof_handler.h>
-
 #  include <deal.II/lac/block_vector.h>
 #  include <deal.II/lac/la_parallel_block_vector.h>
 #  include <deal.II/lac/la_parallel_vector.h>
index f0f533d261068ad618fe9e6957835001d69fa3a4..7d37e1fdbf542cf710372c1dff954c836784c617 100644 (file)
@@ -22,8 +22,6 @@
 #include <deal.II/grid/tria_iterator.h>
 #include <deal.II/grid/tria_iterator.templates.h>
 
-#include <deal.II/hp/dof_handler.h>
-
 #include <vector>
 
 DEAL_II_NAMESPACE_OPEN
index 136aed8a7d56b92eeefffdefeb2600223d625e71..0909f6805ef89a6c572f397a2319b6c55c805a80 100644 (file)
@@ -22,8 +22,6 @@
 #include <deal.II/grid/tria_iterator.h>
 #include <deal.II/grid/tria_iterator.templates.h>
 
-#include <deal.II/hp/dof_handler.h>
-
 #include <deal.II/lac/block_vector.h>
 #include <deal.II/lac/la_parallel_block_vector.h>
 #include <deal.II/lac/la_parallel_vector.h>
index 72a385c0b50d8192c1d0f26fc511378ad585a5d0..739edb6ad92c42cb48a402d5c6a4b8b74e97fb0a 100644 (file)
@@ -22,8 +22,6 @@
 #include <deal.II/grid/tria_iterator.h>
 #include <deal.II/grid/tria_iterator.templates.h>
 
-#include <deal.II/hp/dof_handler.h>
-
 #include <deal.II/lac/block_vector.h>
 #include <deal.II/lac/la_parallel_block_vector.h>
 #include <deal.II/lac/la_parallel_vector.h>
index 6a536218b2da44b25158a924494933c86277dcc8..3e281fc5c9af72488716419d0d57b2ea15596c2a 100644 (file)
@@ -30,7 +30,6 @@
 #include <deal.II/grid/tria.h>
 #include <deal.II/grid/tria_iterator.h>
 
-#include <deal.II/hp/dof_handler.h>
 #include <deal.II/hp/fe_collection.h>
 #include <deal.II/hp/fe_values.h>
 
index ece004aaa1123eb9cebfab46bf2895dccd2692d4..5785431fd8654b215e9fc15ffc8344c722382d4e 100644 (file)
@@ -35,7 +35,6 @@
 #include <deal.II/grid/tria.h>
 #include <deal.II/grid/tria_iterator.h>
 
-#include <deal.II/hp/dof_handler.h>
 #include <deal.II/hp/fe_collection.h>
 #include <deal.II/hp/fe_values.h>
 #include <deal.II/hp/mapping_collection.h>
index e6e2f3daa65fe20e82634c011e68088ef278c17f..6ea53c7509144714275ae4a8dbd6ed562d3ab927 100644 (file)
@@ -59,7 +59,7 @@ DEAL_II_NAMESPACE_OPEN
 
 
 template <int dim, int spacedim, typename VectorType>
-MappingFEField<dim, spacedim, VectorType, void>::InternalData::InternalData(
+MappingFEField<dim, spacedim, VectorType>::InternalData::InternalData(
   const FiniteElement<dim, spacedim> &fe,
   const ComponentMask &               mask)
   : unit_tangentials()
@@ -73,8 +73,8 @@ MappingFEField<dim, spacedim, VectorType, void>::InternalData::InternalData(
 
 template <int dim, int spacedim, typename VectorType>
 std::size_t
-MappingFEField<dim, spacedim, VectorType, void>::InternalData::
-  memory_consumption() const
+MappingFEField<dim, spacedim, VectorType>::InternalData::memory_consumption()
+  const
 {
   Assert(false, ExcNotImplemented());
   return 0;
@@ -84,7 +84,7 @@ MappingFEField<dim, spacedim, VectorType, void>::InternalData::
 
 template <int dim, int spacedim, typename VectorType>
 double &
-MappingFEField<dim, spacedim, VectorType, void>::InternalData::shape(
+MappingFEField<dim, spacedim, VectorType>::InternalData::shape(
   const unsigned int qpoint,
   const unsigned int shape_nr)
 {
@@ -95,7 +95,7 @@ MappingFEField<dim, spacedim, VectorType, void>::InternalData::shape(
 
 template <int dim, int spacedim, typename VectorType>
 const Tensor<1, dim> &
-MappingFEField<dim, spacedim, VectorType, void>::InternalData::derivative(
+MappingFEField<dim, spacedim, VectorType>::InternalData::derivative(
   const unsigned int qpoint,
   const unsigned int shape_nr) const
 {
@@ -108,7 +108,7 @@ MappingFEField<dim, spacedim, VectorType, void>::InternalData::derivative(
 
 template <int dim, int spacedim, typename VectorType>
 Tensor<1, dim> &
-MappingFEField<dim, spacedim, VectorType, void>::InternalData::derivative(
+MappingFEField<dim, spacedim, VectorType>::InternalData::derivative(
   const unsigned int qpoint,
   const unsigned int shape_nr)
 {
@@ -120,9 +120,9 @@ MappingFEField<dim, spacedim, VectorType, void>::InternalData::derivative(
 
 template <int dim, int spacedim, typename VectorType>
 const Tensor<2, dim> &
-MappingFEField<dim, spacedim, VectorType, void>::InternalData::
-  second_derivative(const unsigned int qpoint,
-                    const unsigned int shape_nr) const
+MappingFEField<dim, spacedim, VectorType>::InternalData::second_derivative(
+  const unsigned int qpoint,
+  const unsigned int shape_nr) const
 {
   AssertIndexRange(qpoint * n_shape_functions + shape_nr,
                    shape_second_derivatives.size());
@@ -133,8 +133,9 @@ MappingFEField<dim, spacedim, VectorType, void>::InternalData::
 
 template <int dim, int spacedim, typename VectorType>
 Tensor<2, dim> &
-MappingFEField<dim, spacedim, VectorType, void>::InternalData::
-  second_derivative(const unsigned int qpoint, const unsigned int shape_nr)
+MappingFEField<dim, spacedim, VectorType>::InternalData::second_derivative(
+  const unsigned int qpoint,
+  const unsigned int shape_nr)
 {
   AssertIndexRange(qpoint * n_shape_functions + shape_nr,
                    shape_second_derivatives.size());
@@ -144,7 +145,7 @@ MappingFEField<dim, spacedim, VectorType, void>::InternalData::
 
 template <int dim, int spacedim, typename VectorType>
 const Tensor<3, dim> &
-MappingFEField<dim, spacedim, VectorType, void>::InternalData::third_derivative(
+MappingFEField<dim, spacedim, VectorType>::InternalData::third_derivative(
   const unsigned int qpoint,
   const unsigned int shape_nr) const
 {
@@ -157,7 +158,7 @@ MappingFEField<dim, spacedim, VectorType, void>::InternalData::third_derivative(
 
 template <int dim, int spacedim, typename VectorType>
 Tensor<3, dim> &
-MappingFEField<dim, spacedim, VectorType, void>::InternalData::third_derivative(
+MappingFEField<dim, spacedim, VectorType>::InternalData::third_derivative(
   const unsigned int qpoint,
   const unsigned int shape_nr)
 {
@@ -169,9 +170,9 @@ MappingFEField<dim, spacedim, VectorType, void>::InternalData::third_derivative(
 
 template <int dim, int spacedim, typename VectorType>
 const Tensor<4, dim> &
-MappingFEField<dim, spacedim, VectorType, void>::InternalData::
-  fourth_derivative(const unsigned int qpoint,
-                    const unsigned int shape_nr) const
+MappingFEField<dim, spacedim, VectorType>::InternalData::fourth_derivative(
+  const unsigned int qpoint,
+  const unsigned int shape_nr) const
 {
   AssertIndexRange(qpoint * n_shape_functions + shape_nr,
                    shape_fourth_derivatives.size());
@@ -182,8 +183,9 @@ MappingFEField<dim, spacedim, VectorType, void>::InternalData::
 
 template <int dim, int spacedim, typename VectorType>
 Tensor<4, dim> &
-MappingFEField<dim, spacedim, VectorType, void>::InternalData::
-  fourth_derivative(const unsigned int qpoint, const unsigned int shape_nr)
+MappingFEField<dim, spacedim, VectorType>::InternalData::fourth_derivative(
+  const unsigned int qpoint,
+  const unsigned int shape_nr)
 {
   AssertIndexRange(qpoint * n_shape_functions + shape_nr,
                    shape_fourth_derivatives.size());
@@ -193,7 +195,7 @@ MappingFEField<dim, spacedim, VectorType, void>::InternalData::
 
 
 template <int dim, int spacedim, typename VectorType>
-MappingFEField<dim, spacedim, VectorType, void>::MappingFEField(
+MappingFEField<dim, spacedim, VectorType>::MappingFEField(
   const DoFHandler<dim, spacedim> &euler_dof_handler,
   const VectorType &               euler_vector,
   const ComponentMask &            mask)
@@ -223,7 +225,7 @@ MappingFEField<dim, spacedim, VectorType, void>::MappingFEField(
 
 
 template <int dim, int spacedim, typename VectorType>
-MappingFEField<dim, spacedim, VectorType, void>::MappingFEField(
+MappingFEField<dim, spacedim, VectorType>::MappingFEField(
   const DoFHandler<dim, spacedim> &euler_dof_handler,
   const std::vector<VectorType> &  euler_vector,
   const ComponentMask &            mask)
@@ -263,7 +265,7 @@ MappingFEField<dim, spacedim, VectorType, void>::MappingFEField(
 
 
 template <int dim, int spacedim, typename VectorType>
-MappingFEField<dim, spacedim, VectorType, void>::MappingFEField(
+MappingFEField<dim, spacedim, VectorType>::MappingFEField(
   const DoFHandler<dim, spacedim> &euler_dof_handler,
   const MGLevelObject<VectorType> &euler_vector,
   const ComponentMask &            mask)
@@ -305,8 +307,8 @@ MappingFEField<dim, spacedim, VectorType, void>::MappingFEField(
 
 
 template <int dim, int spacedim, typename VectorType>
-MappingFEField<dim, spacedim, VectorType, void>::MappingFEField(
-  const MappingFEField<dim, spacedim, VectorType, void> &mapping)
+MappingFEField<dim, spacedim, VectorType>::MappingFEField(
+  const MappingFEField<dim, spacedim, VectorType> &mapping)
   : reference_cell(mapping.reference_cell)
   , uses_level_dofs(mapping.uses_level_dofs)
   , euler_vector(mapping.euler_vector)
@@ -322,7 +324,7 @@ MappingFEField<dim, spacedim, VectorType, void>::MappingFEField(
 
 template <int dim, int spacedim, typename VectorType>
 inline const double &
-MappingFEField<dim, spacedim, VectorType, void>::InternalData::shape(
+MappingFEField<dim, spacedim, VectorType>::InternalData::shape(
   const unsigned int qpoint,
   const unsigned int shape_nr) const
 {
@@ -334,8 +336,7 @@ MappingFEField<dim, spacedim, VectorType, void>::InternalData::shape(
 
 template <int dim, int spacedim, typename VectorType>
 bool
-MappingFEField<dim, spacedim, VectorType, void>::preserves_vertex_locations()
-  const
+MappingFEField<dim, spacedim, VectorType>::preserves_vertex_locations() const
 {
   return false;
 }
@@ -344,7 +345,7 @@ MappingFEField<dim, spacedim, VectorType, void>::preserves_vertex_locations()
 
 template <int dim, int spacedim, typename VectorType>
 bool
-MappingFEField<dim, spacedim, VectorType, void>::is_compatible_with(
+MappingFEField<dim, spacedim, VectorType>::is_compatible_with(
   const ReferenceCell &reference_cell) const
 {
   Assert(dim == reference_cell.get_dimension(),
@@ -362,7 +363,7 @@ MappingFEField<dim, spacedim, VectorType, void>::is_compatible_with(
 template <int dim, int spacedim, typename VectorType>
 boost::container::small_vector<Point<spacedim>,
                                GeometryInfo<dim>::vertices_per_cell>
-MappingFEField<dim, spacedim, VectorType, void>::get_vertices(
+MappingFEField<dim, spacedim, VectorType>::get_vertices(
   const typename Triangulation<dim, spacedim>::cell_iterator &cell) const
 {
   // we transform our tria iterator into a dof iterator so we can access
@@ -424,10 +425,9 @@ MappingFEField<dim, spacedim, VectorType, void>::get_vertices(
 
 template <int dim, int spacedim, typename VectorType>
 void
-MappingFEField<dim, spacedim, VectorType, void>::compute_shapes_virtual(
-  const std::vector<Point<dim>> &unit_points,
-  typename MappingFEField<dim, spacedim, VectorType, void>::InternalData &data)
-  const
+MappingFEField<dim, spacedim, VectorType>::compute_shapes_virtual(
+  const std::vector<Point<dim>> &                                   unit_points,
+  typename MappingFEField<dim, spacedim, VectorType>::InternalData &data) const
 {
   const auto         fe       = &euler_dof_handler->get_fe();
   const unsigned int n_points = unit_points.size();
@@ -462,7 +462,7 @@ MappingFEField<dim, spacedim, VectorType, void>::compute_shapes_virtual(
 
 template <int dim, int spacedim, typename VectorType>
 UpdateFlags
-MappingFEField<dim, spacedim, VectorType, void>::requires_update_flags(
+MappingFEField<dim, spacedim, VectorType>::requires_update_flags(
   const UpdateFlags in) const
 {
   // add flags if the respective quantities are necessary to compute
@@ -517,7 +517,7 @@ MappingFEField<dim, spacedim, VectorType, void>::requires_update_flags(
 
 template <int dim, int spacedim, typename VectorType>
 void
-MappingFEField<dim, spacedim, VectorType, void>::compute_data(
+MappingFEField<dim, spacedim, VectorType>::compute_data(
   const UpdateFlags      update_flags,
   const Quadrature<dim> &q,
   const unsigned int     n_original_q_points,
@@ -572,7 +572,7 @@ MappingFEField<dim, spacedim, VectorType, void>::compute_data(
 
 template <int dim, int spacedim, typename VectorType>
 void
-MappingFEField<dim, spacedim, VectorType, void>::compute_face_data(
+MappingFEField<dim, spacedim, VectorType>::compute_face_data(
   const UpdateFlags      update_flags,
   const Quadrature<dim> &q,
   const unsigned int     n_original_q_points,
@@ -616,7 +616,7 @@ MappingFEField<dim, spacedim, VectorType, void>::compute_face_data(
 
 template <int dim, int spacedim, typename VectorType>
 typename std::unique_ptr<typename Mapping<dim, spacedim>::InternalDataBase>
-MappingFEField<dim, spacedim, VectorType, void>::get_data(
+MappingFEField<dim, spacedim, VectorType>::get_data(
   const UpdateFlags      update_flags,
   const Quadrature<dim> &quadrature) const
 {
@@ -632,7 +632,7 @@ MappingFEField<dim, spacedim, VectorType, void>::get_data(
 
 template <int dim, int spacedim, typename VectorType>
 std::unique_ptr<typename Mapping<dim, spacedim>::InternalDataBase>
-MappingFEField<dim, spacedim, VectorType, void>::get_face_data(
+MappingFEField<dim, spacedim, VectorType>::get_face_data(
   const UpdateFlags               update_flags,
   const hp::QCollection<dim - 1> &quadrature) const
 {
@@ -651,7 +651,7 @@ MappingFEField<dim, spacedim, VectorType, void>::get_face_data(
 
 template <int dim, int spacedim, typename VectorType>
 std::unique_ptr<typename Mapping<dim, spacedim>::InternalDataBase>
-MappingFEField<dim, spacedim, VectorType, void>::get_subface_data(
+MappingFEField<dim, spacedim, VectorType>::get_subface_data(
   const UpdateFlags          update_flags,
   const Quadrature<dim - 1> &quadrature) const
 {
@@ -683,7 +683,7 @@ namespace internal
       void
       maybe_compute_q_points(
         const typename dealii::QProjector<dim>::DataSetDescriptor data_set,
-        const typename dealii::MappingFEField<dim, spacedim, VectorType, void>::
+        const typename dealii::MappingFEField<dim, spacedim, VectorType>::
           InternalData &                    data,
         const FiniteElement<dim, spacedim> &fe,
         const ComponentMask &               fe_mask,
@@ -725,7 +725,7 @@ namespace internal
       void
       maybe_update_Jacobians(
         const typename dealii::QProjector<dim>::DataSetDescriptor data_set,
-        const typename dealii::MappingFEField<dim, spacedim, VectorType, void>::
+        const typename dealii::MappingFEField<dim, spacedim, VectorType>::
           InternalData &                    data,
         const FiniteElement<dim, spacedim> &fe,
         const ComponentMask &               fe_mask,
@@ -794,7 +794,7 @@ namespace internal
       void
       maybe_update_jacobian_grads(
         const typename dealii::QProjector<dim>::DataSetDescriptor data_set,
-        const typename dealii::MappingFEField<dim, spacedim, VectorType, void>::
+        const typename dealii::MappingFEField<dim, spacedim, VectorType>::
           InternalData &                               data,
         const FiniteElement<dim, spacedim> &           fe,
         const ComponentMask &                          fe_mask,
@@ -844,7 +844,7 @@ namespace internal
       void
       maybe_update_jacobian_pushed_forward_grads(
         const typename dealii::QProjector<dim>::DataSetDescriptor data_set,
-        const typename dealii::MappingFEField<dim, spacedim, VectorType, void>::
+        const typename dealii::MappingFEField<dim, spacedim, VectorType>::
           InternalData &                    data,
         const FiniteElement<dim, spacedim> &fe,
         const ComponentMask &               fe_mask,
@@ -917,7 +917,7 @@ namespace internal
       void
       maybe_update_jacobian_2nd_derivatives(
         const typename dealii::QProjector<dim>::DataSetDescriptor data_set,
-        const typename dealii::MappingFEField<dim, spacedim, VectorType, void>::
+        const typename dealii::MappingFEField<dim, spacedim, VectorType>::
           InternalData &                               data,
         const FiniteElement<dim, spacedim> &           fe,
         const ComponentMask &                          fe_mask,
@@ -971,7 +971,7 @@ namespace internal
       void
       maybe_update_jacobian_pushed_forward_2nd_derivatives(
         const typename dealii::QProjector<dim>::DataSetDescriptor data_set,
-        const typename dealii::MappingFEField<dim, spacedim, VectorType, void>::
+        const typename dealii::MappingFEField<dim, spacedim, VectorType>::
           InternalData &                    data,
         const FiniteElement<dim, spacedim> &fe,
         const ComponentMask &               fe_mask,
@@ -1067,7 +1067,7 @@ namespace internal
       void
       maybe_update_jacobian_3rd_derivatives(
         const typename dealii::QProjector<dim>::DataSetDescriptor data_set,
-        const typename dealii::MappingFEField<dim, spacedim, VectorType, void>::
+        const typename dealii::MappingFEField<dim, spacedim, VectorType>::
           InternalData &                               data,
         const FiniteElement<dim, spacedim> &           fe,
         const ComponentMask &                          fe_mask,
@@ -1125,7 +1125,7 @@ namespace internal
       void
       maybe_update_jacobian_pushed_forward_3rd_derivatives(
         const typename dealii::QProjector<dim>::DataSetDescriptor data_set,
-        const typename dealii::MappingFEField<dim, spacedim, VectorType, void>::
+        const typename dealii::MappingFEField<dim, spacedim, VectorType>::
           InternalData &                    data,
         const FiniteElement<dim, spacedim> &fe,
         const ComponentMask &               fe_mask,
@@ -1256,7 +1256,7 @@ namespace internal
         const unsigned int                                face_no,
         const unsigned int                                subface_no,
         const typename QProjector<dim>::DataSetDescriptor data_set,
-        const typename dealii::MappingFEField<dim, spacedim, VectorType, void>::
+        const typename dealii::MappingFEField<dim, spacedim, VectorType>::
           InternalData &data,
         internal::FEValuesImplementation::MappingRelatedData<dim, spacedim>
           &output_data)
@@ -1410,7 +1410,7 @@ namespace internal
         const unsigned int                                        face_no,
         const unsigned int                                        subface_no,
         const typename dealii::QProjector<dim>::DataSetDescriptor data_set,
-        const typename dealii::MappingFEField<dim, spacedim, VectorType, void>::
+        const typename dealii::MappingFEField<dim, spacedim, VectorType>::
           InternalData &                    data,
         const FiniteElement<dim, spacedim> &fe,
         const ComponentMask &               fe_mask,
@@ -1488,7 +1488,7 @@ namespace internal
 // need to recalculate data even when cells are similar.
 template <int dim, int spacedim, typename VectorType>
 CellSimilarity::Similarity
-MappingFEField<dim, spacedim, VectorType, void>::fill_fe_values(
+MappingFEField<dim, spacedim, VectorType>::fill_fe_values(
   const typename Triangulation<dim, spacedim>::cell_iterator &cell,
   const CellSimilarity::Similarity,
   const Quadrature<dim> &                                  quadrature,
@@ -1692,7 +1692,7 @@ MappingFEField<dim, spacedim, VectorType, void>::fill_fe_values(
 
 template <int dim, int spacedim, typename VectorType>
 void
-MappingFEField<dim, spacedim, VectorType, void>::fill_fe_face_values(
+MappingFEField<dim, spacedim, VectorType>::fill_fe_face_values(
   const typename Triangulation<dim, spacedim>::cell_iterator &cell,
   const unsigned int                                          face_no,
   const hp::QCollection<dim - 1> &                            quadrature,
@@ -1732,7 +1732,7 @@ MappingFEField<dim, spacedim, VectorType, void>::fill_fe_face_values(
 
 template <int dim, int spacedim, typename VectorType>
 void
-MappingFEField<dim, spacedim, VectorType, void>::fill_fe_subface_values(
+MappingFEField<dim, spacedim, VectorType>::fill_fe_subface_values(
   const typename Triangulation<dim, spacedim>::cell_iterator &cell,
   const unsigned int                                          face_no,
   const unsigned int                                          subface_no,
@@ -1787,17 +1787,15 @@ namespace internal
         const ArrayView<Tensor<rank, spacedim>> &                output)
       {
         AssertDimension(input.size(), output.size());
-        Assert(
-          (dynamic_cast<
-             const typename dealii::
-               MappingFEField<dim, spacedim, VectorType, void>::InternalData *>(
-             &mapping_data) != nullptr),
-          ExcInternalError());
-        const typename dealii::MappingFEField<dim, spacedim, VectorType, void>::
+        Assert((dynamic_cast<
+                  const typename dealii::
+                    MappingFEField<dim, spacedim, VectorType>::InternalData *>(
+                  &mapping_data) != nullptr),
+               ExcInternalError());
+        const typename dealii::MappingFEField<dim, spacedim, VectorType>::
           InternalData &data = static_cast<
-            const typename dealii::
-              MappingFEField<dim, spacedim, VectorType, void>::InternalData &>(
-            mapping_data);
+            const typename dealii::MappingFEField<dim, spacedim, VectorType>::
+              InternalData &>(mapping_data);
 
         switch (mapping_kind)
           {
@@ -1867,17 +1865,15 @@ namespace internal
         const ArrayView<Tensor<rank + 1, spacedim>> &            output)
       {
         AssertDimension(input.size(), output.size());
-        Assert(
-          (dynamic_cast<
-             const typename dealii::
-               MappingFEField<dim, spacedim, VectorType, void>::InternalData *>(
-             &mapping_data) != nullptr),
-          ExcInternalError());
-        const typename dealii::MappingFEField<dim, spacedim, VectorType, void>::
+        Assert((dynamic_cast<
+                  const typename dealii::
+                    MappingFEField<dim, spacedim, VectorType>::InternalData *>(
+                  &mapping_data) != nullptr),
+               ExcInternalError());
+        const typename dealii::MappingFEField<dim, spacedim, VectorType>::
           InternalData &data = static_cast<
-            const typename dealii::
-              MappingFEField<dim, spacedim, VectorType, void>::InternalData &>(
-            mapping_data);
+            const typename dealii::MappingFEField<dim, spacedim, VectorType>::
+              InternalData &>(mapping_data);
 
         switch (mapping_kind)
           {
@@ -1905,7 +1901,7 @@ namespace internal
 
 template <int dim, int spacedim, typename VectorType>
 void
-MappingFEField<dim, spacedim, VectorType, void>::transform(
+MappingFEField<dim, spacedim, VectorType>::transform(
   const ArrayView<const Tensor<1, dim>> &                  input,
   const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
@@ -1924,7 +1920,7 @@ MappingFEField<dim, spacedim, VectorType, void>::transform(
 
 template <int dim, int spacedim, typename VectorType>
 void
-MappingFEField<dim, spacedim, VectorType, void>::transform(
+MappingFEField<dim, spacedim, VectorType>::transform(
   const ArrayView<const DerivativeForm<1, dim, spacedim>> &input,
   const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
@@ -1943,7 +1939,7 @@ MappingFEField<dim, spacedim, VectorType, void>::transform(
 
 template <int dim, int spacedim, typename VectorType>
 void
-MappingFEField<dim, spacedim, VectorType, void>::transform(
+MappingFEField<dim, spacedim, VectorType>::transform(
   const ArrayView<const Tensor<2, dim>> &input,
   const MappingKind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
@@ -1961,7 +1957,7 @@ MappingFEField<dim, spacedim, VectorType, void>::transform(
 
 template <int dim, int spacedim, typename VectorType>
 void
-MappingFEField<dim, spacedim, VectorType, void>::transform(
+MappingFEField<dim, spacedim, VectorType>::transform(
   const ArrayView<const DerivativeForm<2, dim, spacedim>> &input,
   const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
@@ -2009,7 +2005,7 @@ MappingFEField<dim, spacedim, VectorType, void>::transform(
 
 template <int dim, int spacedim, typename VectorType>
 void
-MappingFEField<dim, spacedim, VectorType, void>::transform(
+MappingFEField<dim, spacedim, VectorType>::transform(
   const ArrayView<const Tensor<3, dim>> &input,
   const MappingKind /*mapping_kind*/,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
@@ -2027,7 +2023,7 @@ MappingFEField<dim, spacedim, VectorType, void>::transform(
 
 template <int dim, int spacedim, typename VectorType>
 Point<spacedim>
-MappingFEField<dim, spacedim, VectorType, void>::transform_unit_to_real_cell(
+MappingFEField<dim, spacedim, VectorType>::transform_unit_to_real_cell(
   const typename Triangulation<dim, spacedim>::cell_iterator &cell,
   const Point<dim> &                                          p) const
 {
@@ -2048,7 +2044,7 @@ MappingFEField<dim, spacedim, VectorType, void>::transform_unit_to_real_cell(
 
 template <int dim, int spacedim, typename VectorType>
 Point<spacedim>
-MappingFEField<dim, spacedim, VectorType, void>::do_transform_unit_to_real_cell(
+MappingFEField<dim, spacedim, VectorType>::do_transform_unit_to_real_cell(
   const InternalData &data) const
 {
   Point<spacedim> p_real;
@@ -2069,7 +2065,7 @@ MappingFEField<dim, spacedim, VectorType, void>::do_transform_unit_to_real_cell(
 
 template <int dim, int spacedim, typename VectorType>
 Point<dim>
-MappingFEField<dim, spacedim, VectorType, void>::transform_real_to_unit_cell(
+MappingFEField<dim, spacedim, VectorType>::transform_real_to_unit_cell(
   const typename Triangulation<dim, spacedim>::cell_iterator &cell,
   const Point<spacedim> &                                     p) const
 {
@@ -2117,7 +2113,7 @@ MappingFEField<dim, spacedim, VectorType, void>::transform_real_to_unit_cell(
 
 template <int dim, int spacedim, typename VectorType>
 Point<dim>
-MappingFEField<dim, spacedim, VectorType, void>::do_transform_real_to_unit_cell(
+MappingFEField<dim, spacedim, VectorType>::do_transform_real_to_unit_cell(
   const typename Triangulation<dim, spacedim>::cell_iterator &cell,
   const Point<spacedim> &                                     p,
   const Point<dim> &                                          initial_p_unit,
@@ -2228,7 +2224,7 @@ failure:
 
 template <int dim, int spacedim, typename VectorType>
 unsigned int
-MappingFEField<dim, spacedim, VectorType, void>::get_degree() const
+MappingFEField<dim, spacedim, VectorType>::get_degree() const
 {
   return euler_dof_handler->get_fe().degree;
 }
@@ -2237,7 +2233,7 @@ MappingFEField<dim, spacedim, VectorType, void>::get_degree() const
 
 template <int dim, int spacedim, typename VectorType>
 ComponentMask
-MappingFEField<dim, spacedim, VectorType, void>::get_component_mask() const
+MappingFEField<dim, spacedim, VectorType>::get_component_mask() const
 {
   return this->fe_mask;
 }
@@ -2245,19 +2241,18 @@ MappingFEField<dim, spacedim, VectorType, void>::get_component_mask() const
 
 template <int dim, int spacedim, typename VectorType>
 std::unique_ptr<Mapping<dim, spacedim>>
-MappingFEField<dim, spacedim, VectorType, void>::clone() const
+MappingFEField<dim, spacedim, VectorType>::clone() const
 {
-  return std::make_unique<MappingFEField<dim, spacedim, VectorType, void>>(
-    *this);
+  return std::make_unique<MappingFEField<dim, spacedim, VectorType>>(*this);
 }
 
 
 template <int dim, int spacedim, typename VectorType>
 void
-MappingFEField<dim, spacedim, VectorType, void>::update_internal_dofs(
-  const typename Triangulation<dim, spacedim>::cell_iterator &cell,
-  const typename MappingFEField<dim, spacedim, VectorType, void>::InternalData
-    &data) const
+MappingFEField<dim, spacedim, VectorType>::update_internal_dofs(
+  const typename Triangulation<dim, spacedim>::cell_iterator &            cell,
+  const typename MappingFEField<dim, spacedim, VectorType>::InternalData &data)
+  const
 {
   Assert(euler_dof_handler != nullptr,
          ExcMessage("euler_dof_handler is empty"));
index 64483fedfeffcd3d3ac43206f35740d37d3f8786..809e69b521339db5709c583afef7ed7faccff463 100644 (file)
@@ -33,7 +33,6 @@
 #include <deal.II/grid/tria_accessor.h>
 #include <deal.II/grid/tria_iterator.h>
 
-#include <deal.II/hp/dof_handler.h>
 #include <deal.II/hp/mapping_collection.h>
 
 #include <deal.II/lac/full_matrix.h>
index a5461c2f65cc77293f66f8c284c36214e886a169..59c0dd16e537a2e6ba10f1990b4cd3d5d47d967c 100644 (file)
@@ -26,7 +26,6 @@
 #include <deal.II/grid/tria.h>
 #include <deal.II/grid/tria_iterator.h>
 
-#include <deal.II/hp/dof_handler.h>
 #include <deal.II/hp/fe_values.h>
 
 #include <deal.II/numerics/data_out.h>
index 1554c292efb369ba72495f4828255bf9497031c1..6d1b5c5d6ad308eff4163c5f630a2c00a8e71c16 100644 (file)
@@ -39,7 +39,7 @@ DEAL_II_NAMESPACE_OPEN
 
 template <int dim, int spacedim>
 std::size_t
-DataOutStack<dim, spacedim, void>::DataVector::memory_consumption() const
+DataOutStack<dim, spacedim>::DataVector::memory_consumption() const
 {
   return (MemoryConsumption::memory_consumption(data) +
           MemoryConsumption::memory_consumption(names));
@@ -49,8 +49,8 @@ DataOutStack<dim, spacedim, void>::DataVector::memory_consumption() const
 
 template <int dim, int spacedim>
 void
-DataOutStack<dim, spacedim, void>::new_parameter_value(const double p,
-                                                       const double dp)
+DataOutStack<dim, spacedim>::new_parameter_value(const double p,
+                                                 const double dp)
 {
   parameter      = p;
   parameter_step = dp;
@@ -72,7 +72,7 @@ DataOutStack<dim, spacedim, void>::new_parameter_value(const double p,
 
 template <int dim, int spacedim>
 void
-DataOutStack<dim, spacedim, void>::attach_dof_handler(
+DataOutStack<dim, spacedim>::attach_dof_handler(
   const DoFHandler<dim, spacedim> &dof)
 {
   dof_handler = &dof;
@@ -81,9 +81,8 @@ DataOutStack<dim, spacedim, void>::attach_dof_handler(
 
 template <int dim, int spacedim>
 void
-DataOutStack<dim, spacedim, void>::declare_data_vector(
-  const std::string &name,
-  const VectorType   vector_type)
+DataOutStack<dim, spacedim>::declare_data_vector(const std::string &name,
+                                                 const VectorType   vector_type)
 {
   std::vector<std::string> names;
   names.push_back(name);
@@ -93,7 +92,7 @@ DataOutStack<dim, spacedim, void>::declare_data_vector(
 
 template <int dim, int spacedim>
 void
-DataOutStack<dim, spacedim, void>::declare_data_vector(
+DataOutStack<dim, spacedim>::declare_data_vector(
   const std::vector<std::string> &names,
   const VectorType                vector_type)
 {
@@ -136,8 +135,8 @@ DataOutStack<dim, spacedim, void>::declare_data_vector(
 template <int dim, int spacedim>
 template <typename number>
 void
-DataOutStack<dim, spacedim, void>::add_data_vector(const Vector<number> &vec,
-                                                   const std::string &   name)
+DataOutStack<dim, spacedim>::add_data_vector(const Vector<number> &vec,
+                                             const std::string &   name)
 {
   const unsigned int n_components = dof_handler->get_fe(0).n_components();
 
@@ -170,7 +169,7 @@ DataOutStack<dim, spacedim, void>::add_data_vector(const Vector<number> &vec,
 template <int dim, int spacedim>
 template <typename number>
 void
-DataOutStack<dim, spacedim, void>::add_data_vector(
+DataOutStack<dim, spacedim>::add_data_vector(
   const Vector<number> &          vec,
   const std::vector<std::string> &names)
 {
@@ -244,8 +243,7 @@ DataOutStack<dim, spacedim, void>::add_data_vector(
 
 template <int dim, int spacedim>
 void
-DataOutStack<dim, spacedim, void>::build_patches(
-  const unsigned int nnnn_subdivisions)
+DataOutStack<dim, spacedim>::build_patches(const unsigned int nnnn_subdivisions)
 {
   // this is mostly copied from the
   // DataOut class
@@ -432,7 +430,7 @@ DataOutStack<dim, spacedim, void>::build_patches(
 
 template <int dim, int spacedim>
 void
-DataOutStack<dim, spacedim, void>::finish_parameter_value()
+DataOutStack<dim, spacedim>::finish_parameter_value()
 {
   // release lock on dof handler
   dof_handler = nullptr;
@@ -451,7 +449,7 @@ DataOutStack<dim, spacedim, void>::finish_parameter_value()
 
 template <int dim, int spacedim>
 std::size_t
-DataOutStack<dim, spacedim, void>::memory_consumption() const
+DataOutStack<dim, spacedim>::memory_consumption() const
 {
   return (DataOutInterface<patch_dim, patch_spacedim>::memory_consumption() +
           MemoryConsumption::memory_consumption(parameter) +
@@ -466,10 +464,9 @@ DataOutStack<dim, spacedim, void>::memory_consumption() const
 
 template <int dim, int spacedim>
 const std::vector<
-  dealii::DataOutBase::Patch<DataOutStack<dim, spacedim, void>::patch_dim,
-                             DataOutStack<dim, spacedim, void>::patch_spacedim>>
-  &
-  DataOutStack<dim, spacedim, void>::get_patches() const
+  dealii::DataOutBase::Patch<DataOutStack<dim, spacedim>::patch_dim,
+                             DataOutStack<dim, spacedim>::patch_spacedim>> &
+DataOutStack<dim, spacedim>::get_patches() const
 {
   return patches;
 }
@@ -478,7 +475,7 @@ const std::vector<
 
 template <int dim, int spacedim>
 std::vector<std::string>
-DataOutStack<dim, spacedim, void>::get_dataset_names() const
+DataOutStack<dim, spacedim>::get_dataset_names() const
 {
   std::vector<std::string> names;
   for (typename std::vector<DataVector>::const_iterator dataset =
index 5a5f936c26b9a5778538f597fce3364bf9cdb83f..152902930b4a830268ab15a103675af476fd892f 100644 (file)
@@ -17,8 +17,6 @@
 #include <deal.II/dofs/dof_accessor.h>
 #include <deal.II/dofs/dof_handler.h>
 
-#include <deal.II/hp/dof_handler.h>
-
 #include <deal.II/lac/block_vector.h>
 #include <deal.II/lac/la_parallel_block_vector.h>
 #include <deal.II/lac/la_parallel_vector.h>
index 691f2928885ef3252e4ee241fc5896fabb39670f..14a4d644b83b27d7093379b999223937cbdb89fc 100644 (file)
 #include <deal.II/base/quadrature.h>
 #include <deal.II/base/signaling_nan.h>
 
+#include <deal.II/dofs/dof_handler.h>
+
 #include <deal.II/fe/fe_series.h>
 
 #include <deal.II/grid/filtered_iterator.h>
 
-#include <deal.II/hp/dof_handler.h>
 #include <deal.II/hp/q_collection.h>
 
 #include <deal.II/lac/block_vector.h>
index 95fb337adc5edf5994e8dbb34e841e88379a0e73..190789ac3b6473f76bc291c065e7aa7ec6b48f5f 100644 (file)
@@ -100,8 +100,8 @@ make_constraint_matrix(const DoFHandler<2> &dof_handler, int version)
           dof_handler, 1, 0, 0, periodicity_vectorDof);
     }
 
-  DoFTools::make_periodicity_constraints<DoFHandler<dim>>(periodicity_vectorDof,
-                                                          constraints);
+  DoFTools::make_periodicity_constraints<dim, dim>(periodicity_vectorDof,
+                                                   constraints);
 
   constraints.close();
   std::map<types::global_dof_index, Point<dim>> support_points;
index 5d258e17657a2e70f208e14034fb1393bf6ff498..3b3f82211d776705bffc4b9de19d9f6725cdf740 100644 (file)
@@ -89,8 +89,8 @@ make_constraint_matrix(const DoFHandler<3> &dof_handler, int version)
           dof_handler, 1, 0, 0, periodicity_vectorDof);
     }
 
-  DoFTools::make_periodicity_constraints<DoFHandler<dim>>(periodicity_vectorDof,
-                                                          constraints);
+  DoFTools::make_periodicity_constraints<dim, dim>(periodicity_vectorDof,
+                                                   constraints);
 
   constraints.close();
   std::map<types::global_dof_index, Point<dim>> support_points;
index fe22054cc2c3bc930b5420838069bcac04da37f7..30d8ae62b6516d96fd99015806ef58b5a1ad523c 100644 (file)
@@ -63,7 +63,7 @@ public:
 
         // get the cell this all belongs to
         typename DoFHandler<dim>::cell_iterator cell =
-          input_data.template get_cell<DoFHandler<dim>>();
+          input_data.template get_cell<dim>();
 
         Assert(input_data.solution_values[q] ==
                  double(cell->active_cell_index()),
index c09e6a2e6e980c136ca453e25bd4ab8cfa8d28dc..8d46556fd93837d0f92d6534c429c49faa0b40b3 100644 (file)
@@ -65,7 +65,7 @@ public:
 
         // get the cell this all belongs to
         typename DoFHandler<dim>::cell_iterator cell =
-          input_data.template get_cell<DoFHandler<dim>>();
+          input_data.template get_cell<dim>();
 
         Assert(input_data.solution_values[q](0) ==
                  double(cell->active_cell_index()),
index 6879593bf7f5517d1f6ce31322cc4786c9e047a6..f1ea121e621f8fc4192d1b6e42725507143a8e10 100644 (file)
@@ -63,7 +63,7 @@ public:
 
         // get the cell this all belongs to
         typename DoFHandler<dim>::cell_iterator cell =
-          input_data.template get_cell<DoFHandler<dim>>();
+          input_data.template get_cell<dim>();
 
         Assert(input_data.solution_values[q] ==
                  double(cell->active_cell_index()),
index 6472eb9e7f4f4fa415658aac132877905fa9b231..ae6fdff3a1e5662f8fe3c7fb56a3de6a31cac314 100644 (file)
@@ -65,7 +65,7 @@ public:
 
         // get the cell this all belongs to
         typename DoFHandler<dim>::cell_iterator cell =
-          input_data.template get_cell<DoFHandler<dim>>();
+          input_data.template get_cell<dim>();
 
         Assert(input_data.solution_values[q](0) ==
                  double(cell->active_cell_index()),
index 85c3fa007f1cf1dd94ef6aae459f9c292a98a9be..060db14cdcc3c11a07c33315c1f2b62b93b5f484 100644 (file)
@@ -63,7 +63,7 @@ public:
 
         // get the cell this all belongs to
         typename DoFHandler<dim>::cell_iterator cell =
-          input_data.template get_cell<DoFHandler<dim>>();
+          input_data.template get_cell<dim>();
 
         Assert(input_data.solution_values[q] ==
                  double(cell->active_cell_index()),
index 1fd127e4d506f5c2f782cdb71398a6fc72580439..5bd417f2e7043338d65c137325e57f166fb47925 100644 (file)
@@ -90,7 +90,7 @@ test()
        cell != dof_handler.end();
        ++cell)
     deallog << cell << ": "
-            << DoFTools::count_dofs_on_patch<DoFHandler<dim>>(
+            << DoFTools::count_dofs_on_patch<dim, dim>(
                  GridTools::get_patch_around_cell<DoFHandler<dim>>(cell))
             << std::endl;
 }
index 4144d216536bd2d6ce6ff88125569783522dcd08..902f9ac0f4bb652a2b96b2d6ebe2a9e8e034da40 100644 (file)
@@ -58,11 +58,11 @@ check()
   // try all possible block
   // masks, which we encode as bit
   // strings
-  for (unsigned int int_mask = 0; int_mask < (1U << element[0].n_blocks());
+  for (unsigned int int_mask = 0; int_mask < (1U << element.n_blocks());
        ++int_mask)
     {
-      std::vector<bool> component_mask(element[0].n_blocks());
-      for (unsigned int c = 0; c < element[0].n_blocks(); ++c)
+      std::vector<bool> component_mask(element.n_blocks());
+      for (unsigned int c = 0; c < element.n_blocks(); ++c)
         component_mask[c] = (int_mask & (1 << c));
 
       for (unsigned int level = 0; level < tr.n_levels(); ++level)
index 9ee2d2eaf64513a1ef027f463956d1297753bbb4..289332c177ea6b7222a40c9144c794e75ee5113e 100644 (file)
@@ -91,7 +91,7 @@ test()
        ++cell)
     {
       const std::vector<types::global_dof_index> m =
-        DoFTools::get_dofs_on_patch<DoFHandler<dim>>(
+        DoFTools::get_dofs_on_patch<dim, dim>(
           GridTools::get_patch_around_cell<DoFHandler<dim>>(cell));
       deallog << cell << ": ";
       for (unsigned int i = 0; i < m.size(); ++i)
index 874f4ceeba636f243a4a4f126ae2a55dbd4ccfb6..10ac6975e8b5ff13b2f08b823807c63e62806b78 100644 (file)
@@ -22,7 +22,8 @@
 
 #include <deal.II/base/function.h>
 
-#include <deal.II/hp/dof_handler.h>
+#include <deal.II/dofs/dof_handler.h>
+
 #include <deal.II/hp/fe_values.h>
 
 #include "../tests.h"
@@ -118,13 +119,10 @@ test()
       quadrature_collection_mf.push_back(QGauss<1>(deg + 1));
     }
 
-  hp::DoFHandler<dim> dof(tria);
+  DoFHandler<dim> dof(tria);
   // set the active FE index in a random order
   {
-    typename hp::DoFHandler<dim>::active_cell_iterator cell =
-                                                         dof.begin_active(),
-                                                       endc = dof.end();
-    for (; cell != endc; ++cell)
+    for (const auto &cell : dof.active_cell_iterators())
       {
         const unsigned int fe_index = Testing::rand() % max_degree;
         cell->set_active_fe_index(fe_index + 1);
@@ -132,8 +130,7 @@ test()
     // We cannot set random cells to FE_Nothing. We get the following error
     // The violated condition was: dominating_fe.n_dofs_per_face(face) <=
     // subface_fe.n_dofs_per_face(face)
-    cell = dof.begin_active();
-    cell->set_active_fe_index(0);
+    dof.begin_active()->set_active_fe_index(0);
   }
 
   // setup DoFs
@@ -173,10 +170,7 @@ test()
     FullMatrix<double>                   cell_matrix;
     std::vector<types::global_dof_index> local_dof_indices;
 
-    typename hp::DoFHandler<dim>::active_cell_iterator cell =
-                                                         dof.begin_active(),
-                                                       endc = dof.end();
-    for (; cell != endc; ++cell)
+    for (const auto &cell : dof.active_cell_iterators())
       {
         const unsigned int dofs_per_cell = cell->get_fe().dofs_per_cell;
 
index afa527c7c4c994caa85569b375c8bce05883d1b0..99b3c0dae24b7e241b94fe174b588c0fa5d86fcc 100644 (file)
@@ -383,11 +383,11 @@ namespace Step22
       GridTools::collect_periodic_faces(
         dof_handler, 2, 3, 1, periodicity_vector, Tensor<1, dim>(), matrix);
 
-      DoFTools::make_periodicity_constraints<DoFHandler<dim>>(
-        periodicity_vector,
-        constraints,
-        fe.component_mask(velocities),
-        first_vector_components);
+      DoFTools::make_periodicity_constraints<dim, dim>(periodicity_vector,
+                                                       constraints,
+                                                       fe.component_mask(
+                                                         velocities),
+                                                       first_vector_components);
 #endif
     }
 
index aab14a4df767473b5bfe8680309a148a43472326..ba78ca4f42f644f79e63a8713e4248714b753bae 100644 (file)
@@ -287,11 +287,11 @@ namespace Step22
       GridTools::collect_periodic_faces(
         dof_handler, 4, 0, 1, periodicity_vector, offset, rot_matrix);
 
-      DoFTools::make_periodicity_constraints<DoFHandler<dim>>(
-        periodicity_vector,
-        constraints,
-        fe.component_mask(velocities),
-        first_vector_components);
+      DoFTools::make_periodicity_constraints<dim, dim>(periodicity_vector,
+                                                       constraints,
+                                                       fe.component_mask(
+                                                         velocities),
+                                                       first_vector_components);
 
       VectorTools::interpolate_boundary_values(dof_handler,
                                                1,
index 45cef283e7edf1e9665c33b51a2a6224c42382ef..0d3502472a55d88c48ea4256ddfded397730f478 100644 (file)
@@ -198,8 +198,8 @@ check(const unsigned int orientation, bool reverse)
     GridTools::collect_periodic_faces(
       dof_handler, 42, 43, dim - 1, periodicity_vector);
 
-    DoFTools::make_periodicity_constraints<DoFHandler<dim>>(periodicity_vector,
-                                                            constraints);
+    DoFTools::make_periodicity_constraints<dim, dim>(periodicity_vector,
+                                                     constraints);
   }
   constraints.close();
 
index 679a4ff32b3cb5fc46926dde94b9013e127eccb9..3992c23fcabe927fa67034c0895d97f54d001a8d 100644 (file)
@@ -183,8 +183,8 @@ test(const unsigned numRefinementLevels = 2)
                                       /*direction*/ d,
                                       periodicity_vectorDof);
 
-  DoFTools::make_periodicity_constraints<DoFHandler<dim>>(periodicity_vectorDof,
-                                                          constraints);
+  DoFTools::make_periodicity_constraints<dim, dim>(periodicity_vectorDof,
+                                                   constraints);
   constraints.close();
 
   const std::vector<IndexSet> &locally_owned_dofs =
index 8d9ccecaafe93f7a699b1bb316fcf5b4566c4c27..129910f3a3598d31ebb4840a468d7a7abad37b30 100644 (file)
@@ -162,8 +162,8 @@ test(const unsigned numRefinementLevels = 2)
                                       /*direction*/ d,
                                       periodicity_vectorDof);
 
-  DoFTools::make_periodicity_constraints<DoFHandler<dim>>(periodicity_vectorDof,
-                                                          constraints);
+  DoFTools::make_periodicity_constraints<dim, dim>(periodicity_vectorDof,
+                                                   constraints);
 
   const bool consistent =
     constraints.is_consistent_in_parallel(locally_owned_dofs,

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.