]> https://gitweb.dealii.org/ - dealii.git/commitdiff
dealii::DoFHandler -> DoFHandler
authorDavid Wells <drwells@email.unc.edu>
Wed, 22 Mar 2023 12:23:05 +0000 (08:23 -0400)
committerDavid Wells <drwells@email.unc.edu>
Wed, 22 Mar 2023 22:40:36 +0000 (18:40 -0400)
26 files changed:
include/deal.II/distributed/cell_weights.h
include/deal.II/dofs/dof_accessor.templates.h
include/deal.II/dofs/dof_faces.h
include/deal.II/dofs/dof_levels.h
include/deal.II/dofs/dof_objects.h
include/deal.II/dofs/dof_tools.h
include/deal.II/grid/grid_tools.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/matrix_free/matrix_free.templates.h
include/deal.II/multigrid/mg_transfer.templates.h
include/deal.II/multigrid/multigrid.h
include/deal.II/numerics/vector_tools_integrate_difference.templates.h
source/distributed/cell_weights.cc
source/dofs/dof_handler.cc
source/dofs/dof_handler_policy.cc
source/dofs/dof_tools.cc
source/dofs/dof_tools_constraints.cc
source/dofs/dof_tools_sparsity.cc
source/fe/fe_q_bubbles.cc
source/grid/grid_tools_dof_handlers.cc
source/grid/grid_tools_dof_handlers.inst.in
source/multigrid/mg_transfer_block.cc
source/multigrid/mg_transfer_component.cc
source/multigrid/mg_transfer_internal.cc
source/multigrid/mg_transfer_internal.inst.in
source/numerics/solution_transfer.cc

index dbb16287c3f13a0e8725c50713f35927b7205e43..3a742de8fca8f4d4bd99db0c0ab3b4eb7d47c9cf 100644 (file)
@@ -129,8 +129,8 @@ namespace parallel
      * @param[in] weighting_function The function that determines each
      *    cell's weight during load balancing.
      */
-    CellWeights(const dealii::DoFHandler<dim, spacedim> &dof_handler,
-                const WeightingFunction &                weighting_function);
+    CellWeights(const DoFHandler<dim, spacedim> &dof_handler,
+                const WeightingFunction &        weighting_function);
 
     /**
      * Destructor.
index a50119e66ae2e59098fb5c431b973020220f20fc..6307d62a86aca8759679410190634b7c67782d65 100644 (file)
@@ -2113,8 +2113,8 @@ namespace internal
     // dealii::DoFCellAccessor, not
     // namespace
     // dealii::internal::DoFCellAccessor
+    using DoFHandler;
     using dealii::DoFCellAccessor;
-    using dealii::DoFHandler;
 
     /**
      * A class with the same purpose as the similarly named class of the
index 62031a7795ca4d849d363f3542851386c88fcb81..7f1e5e9f1b4a62d354249c49b675c707b1d9da9d 100644 (file)
@@ -62,7 +62,7 @@ namespace internal
      * variables using the DoFHandler::get_dof_index() and corresponding
      * setter functions. Knowledge of the actual data format is therefore
      * encapsulated to the present hierarchy of classes as well as the
-     * dealii::DoFHandler class.
+     * DoFHandler class.
      */
     template <int dim>
     class DoFFaces
index 706661b80a9181a06e8f9d423480819c7d61ea26..7b40338071f1ea369c90c1adf3febdcfda42c065 100644 (file)
@@ -41,7 +41,7 @@ namespace internal
      * Note that vertices use a storage scheme that is entirely separate from
      * the one used for the cells. The indices of degrees of freedom located
      * on vertices are therefore not stored here, but rather in member
-     * variables of the dealii::DoFHandler class.
+     * variables of the DoFHandler class.
      *
      * The indices of degrees of freedom located on lower dimensional objects,
      * i.e. on lines for 2d and on quads and lines for 3d are treated
@@ -57,7 +57,7 @@ namespace internal
      * variables using the DoFHandler::get_dof_index() and corresponding
      * setter functions. Knowledge of the actual data format is therefore
      * encapsulated to the present hierarchy of classes as well as the
-     * dealii::DoFHandler class.
+     * DoFHandler class.
      */
     template <int dim>
     class DoFLevel
index decfe958fa3e0fa09691504b4d4afdac3e2f9d29..bfd14f04ec39953b411da3c94054250f49a595d2 100644 (file)
@@ -90,10 +90,10 @@ namespace internal
        */
       template <int dh_dim, int spacedim>
       types::global_dof_index &
-      access_dof_index(const dealii::DoFHandler<dh_dim, spacedim> &dof_handler,
-                       const unsigned int                          obj_index,
-                       const types::fe_index                       fe_index,
-                       const unsigned int                          local_index);
+      access_dof_index(const DoFHandler<dh_dim, spacedim> &dof_handler,
+                       const unsigned int                  obj_index,
+                       const types::fe_index               fe_index,
+                       const unsigned int                  local_index);
 
       /**
        * Return the value 1. The meaning of this function becomes clear by
@@ -102,9 +102,8 @@ namespace internal
        */
       template <int dh_dim, int spacedim>
       unsigned int
-      n_active_fe_indices(
-        const dealii::DoFHandler<dh_dim, spacedim> &dof_handler,
-        const types::global_dof_index               index) const;
+      n_active_fe_indices(const DoFHandler<dh_dim, spacedim> &dof_handler,
+                          const types::global_dof_index       index) const;
 
       /**
        * Similar to the function above. Assert that the given index is zero,
@@ -112,10 +111,9 @@ namespace internal
        */
       template <int dh_dim, int spacedim>
       bool
-      fe_index_is_active(
-        const dealii::DoFHandler<dh_dim, spacedim> &dof_handler,
-        const types::global_dof_index               index,
-        const types::fe_index                       fe_index) const;
+      fe_index_is_active(const DoFHandler<dh_dim, spacedim> &dof_handler,
+                         const types::global_dof_index       index,
+                         const types::fe_index               fe_index) const;
 
       /**
        * Determine an estimate for the memory consumption (in bytes) of this
@@ -147,9 +145,8 @@ namespace internal
     template <int dim>
     template <int dh_dim, int spacedim>
     inline unsigned int
-    DoFObjects<dim>::n_active_fe_indices(
-      const dealii::DoFHandler<dh_dim, spacedim> &,
-      const types::global_dof_index) const
+    DoFObjects<dim>::n_active_fe_indices(const DoFHandler<dh_dim, spacedim> &,
+                                         const types::global_dof_index) const
     {
       return 1;
     }
@@ -159,14 +156,12 @@ namespace internal
     template <int dim>
     template <int dh_dim, int spacedim>
     inline bool
-    DoFObjects<dim>::fe_index_is_active(
-      const dealii::DoFHandler<dh_dim, spacedim> &,
-      const types::global_dof_index,
-      const types::fe_index fe_index) const
+    DoFObjects<dim>::fe_index_is_active(const DoFHandler<dh_dim, spacedim> &,
+                                        const types::global_dof_index,
+                                        const types::fe_index fe_index) const
     {
       (void)fe_index;
-      Assert((fe_index ==
-              dealii::DoFHandler<dh_dim, spacedim>::default_fe_index),
+      Assert((fe_index == DoFHandler<dh_dim, spacedim>::default_fe_index),
              ExcMessage("Only zero fe_index values are allowed for "
                         "non-hp-DoFHandlers."));
       return true;
@@ -178,14 +173,13 @@ namespace internal
     template <int dh_dim, int spacedim>
     inline types::global_dof_index &
     DoFObjects<dim>::access_dof_index(
-      const dealii::DoFHandler<dh_dim, spacedim> &dof_handler,
-      const unsigned int                          obj_index,
-      const types::fe_index                       fe_index,
-      const unsigned int                          local_index)
+      const DoFHandler<dh_dim, spacedim> &dof_handler,
+      const unsigned int                  obj_index,
+      const types::fe_index               fe_index,
+      const unsigned int                  local_index)
     {
       (void)fe_index;
-      Assert((fe_index ==
-              dealii::DoFHandler<dh_dim, spacedim>::default_fe_index),
+      Assert((fe_index == DoFHandler<dh_dim, spacedim>::default_fe_index),
              ExcMessage("Only the default FE index is allowed for DoFHandler "
                         "objects without hp capability"));
       AssertIndexRange(local_index,
index a2431e8ecedf20062e07f2019e2ed2db42cfddaa..5dc6be5f22c38593f744cd252bd7f3e2031250b2 100644 (file)
@@ -626,8 +626,8 @@ namespace DoFTools
    * in the triangulation. By default flux couplings are added over all internal
    * faces. @p face_has_flux_coupling should be a function that takes an
    * active_cell_iterator and a face index and should return true if there is a
-   * flux coupling over the face. When using the ::dealii::DoFHandler we could,
-   * for example, use
+   * flux coupling over the face. When using DoFHandler we could, for example,
+   * use
    *
    * @code
    *  auto face_has_flux_coupling =
index 4844cc20265e4fd024854308a4c541639eec4204..01b6e63643a2fdf9bd034b417c3539f2994e5bf8 100644 (file)
@@ -111,7 +111,7 @@ namespace internal
 
 #ifdef _MSC_VER
   template <int dim, int spacedim>
-  class ActiveCellIterator<dim, spacedim, dealii::DoFHandler<dim, spacedim>>
+  class ActiveCellIterator<dim, spacedim, DoFHandler<dim, spacedim>>
   {
   public:
     using type =
@@ -3194,7 +3194,7 @@ namespace GridTools
    * those processors:
    * @code
    * using active_cell_iterator =
-   *   typename dealii::DoFHandler<dim,spacedim>::active_cell_iterator;
+   *   typename DoFHandler<dim,spacedim>::active_cell_iterator;
    * auto pack = [] (const active_cell_iterator &cell) -> unsigned int
    *             {
    *               return cell->active_fe_index();
@@ -3207,7 +3207,7 @@ namespace GridTools
    *               };
    *
    * GridTools::exchange_cell_data_to_ghosts<
-   *   unsigned int, dealii::DoFHandler<dim,spacedim>> (dof_handler,
+   *   unsigned int, DoFHandler<dim,spacedim>> (dof_handler,
    *                                                    pack,
    *                                                    unpack);
    * @endcode
index c33b4c62859850472320b37df619872ece18fa15..05fc6890148e0b0feca1c907d23ce1efa7ae3ac2 100644 (file)
@@ -3123,8 +3123,8 @@ namespace internal
     template <int dim, int spacedim>
     inline std::vector<IndexSet>
     extract_locally_owned_index_sets(
-      const std::vector<const ::dealii::DoFHandler<dim, spacedim> *> &dofh,
-      const unsigned int                                              level)
+      const std::vector<const DoFHandler<dim, spacedim> *> &dofh,
+      const unsigned int                                    level)
     {
       std::vector<IndexSet> locally_owned_set;
       locally_owned_set.reserve(dofh.size());
index 447af78ff75a2fc8e0d6d73a8aeead6274f584b7..716265595192d6359d81c33693015f0214ac3806 100644 (file)
@@ -1125,9 +1125,9 @@ namespace internal
   std::vector<bool>
   compute_dof_info(
     const std::vector<const dealii::AffineConstraints<number> *> &constraint,
-    const std::vector<IndexSet> &locally_owned_dofs,
-    const std::vector<SmartPointer<const dealii::DoFHandler<dim>>> &dof_handler,
-    const Table<2, MatrixFreeFunctions::ShapeInfo<double>> &        shape_infos,
+    const std::vector<IndexSet> &                           locally_owned_dofs,
+    const std::vector<SmartPointer<const DoFHandler<dim>>> &dof_handler,
+    const Table<2, MatrixFreeFunctions::ShapeInfo<double>> &shape_infos,
     const unsigned int               cell_level_index_end_local,
     const unsigned int               mg_level,
     const bool                       hold_all_faces_to_owned_cells,
index 419a6774886f04bb852025320b4619c674aa240e..6373a7c7618157ffeec330045072325763f7ed95 100644 (file)
@@ -56,7 +56,7 @@ namespace internal
      */
     template <int dim, typename number, int spacedim>
     void
-    reinit_vector(const dealii::DoFHandler<dim, spacedim> &dof_handler,
+    reinit_vector(const DoFHandler<dim, spacedim> &dof_handler,
                   const std::vector<unsigned int> &,
                   MGLevelObject<dealii::Vector<number>> &v)
     {
@@ -75,9 +75,9 @@ namespace internal
      */
     template <int dim, typename number, int spacedim>
     void
-    reinit_vector(const dealii::DoFHandler<dim, spacedim> &dof_handler,
-                  std::vector<unsigned int>                target_component,
-                  MGLevelObject<BlockVector<number>> &     v)
+    reinit_vector(const DoFHandler<dim, spacedim> &   dof_handler,
+                  std::vector<unsigned int>           target_component,
+                  MGLevelObject<BlockVector<number>> &v)
     {
       const unsigned int n_blocks = dof_handler.get_fe().n_blocks();
       if (target_component.size() == 0)
@@ -115,7 +115,7 @@ namespace internal
      */
     template <int dim, int spacedim>
     void
-    reinit_vector(const dealii::DoFHandler<dim, spacedim> &dof_handler,
+    reinit_vector(const DoFHandler<dim, spacedim> &dof_handler,
                   const std::vector<unsigned int> &,
                   MGLevelObject<TrilinosWrappers::MPI::Vector> &v)
     {
@@ -143,7 +143,7 @@ namespace internal
      */
     template <int dim, int spacedim>
     void
-    reinit_vector(const dealii::DoFHandler<dim, spacedim> &dof_handler,
+    reinit_vector(const DoFHandler<dim, spacedim> &dof_handler,
                   const std::vector<unsigned int> &,
                   MGLevelObject<PETScWrappers::MPI::Vector> &v)
     {
index 34d4306660b2cbc92fbe80ca29b0bd0bfafe8d9e..23864c78d7c8a1cee55d4bf4276b13c3a15575e8 100644 (file)
@@ -709,15 +709,14 @@ namespace internal
               class TRANSFER,
               typename OtherVectorType>
     std::enable_if_t<TRANSFER::supports_dof_handler_vector>
-    vmult(
-      const std::vector<const dealii::DoFHandler<dim> *> &dof_handler_vector,
-      dealii::Multigrid<VectorType> &                     multigrid,
-      const TRANSFER &                                    transfer,
-      OtherVectorType &                                   dst,
-      const OtherVectorType &                             src,
-      const bool                          uses_dof_handler_vector,
-      const typename dealii::mg::Signals &signals,
-      int)
+    vmult(const std::vector<const DoFHandler<dim> *> &dof_handler_vector,
+          dealii::Multigrid<VectorType> &             multigrid,
+          const TRANSFER &                            transfer,
+          OtherVectorType &                           dst,
+          const OtherVectorType &                     src,
+          const bool                                  uses_dof_handler_vector,
+          const typename dealii::mg::Signals &        signals,
+          int)
     {
       signals.transfer_to_mg(true);
       if (uses_dof_handler_vector)
@@ -741,15 +740,14 @@ namespace internal
               class TRANSFER,
               typename OtherVectorType>
     void
-    vmult(
-      const std::vector<const dealii::DoFHandler<dim> *> &dof_handler_vector,
-      dealii::Multigrid<VectorType> &                     multigrid,
-      const TRANSFER &                                    transfer,
-      OtherVectorType &                                   dst,
-      const OtherVectorType &                             src,
-      const bool                          uses_dof_handler_vector,
-      const typename dealii::mg::Signals &signals,
-      ...)
+    vmult(const std::vector<const DoFHandler<dim> *> &dof_handler_vector,
+          dealii::Multigrid<VectorType> &             multigrid,
+          const TRANSFER &                            transfer,
+          OtherVectorType &                           dst,
+          const OtherVectorType &                     src,
+          const bool                                  uses_dof_handler_vector,
+          const typename dealii::mg::Signals &        signals,
+          ...)
     {
       (void)uses_dof_handler_vector;
       Assert(!uses_dof_handler_vector, ExcInternalError());
@@ -770,15 +768,14 @@ namespace internal
               class TRANSFER,
               typename OtherVectorType>
     std::enable_if_t<TRANSFER::supports_dof_handler_vector>
-    vmult_add(
-      const std::vector<const dealii::DoFHandler<dim> *> &dof_handler_vector,
-      dealii::Multigrid<VectorType> &                     multigrid,
-      const TRANSFER &                                    transfer,
-      OtherVectorType &                                   dst,
-      const OtherVectorType &                             src,
-      const bool                          uses_dof_handler_vector,
-      const typename dealii::mg::Signals &signals,
-      int)
+    vmult_add(const std::vector<const DoFHandler<dim> *> &dof_handler_vector,
+              dealii::Multigrid<VectorType> &             multigrid,
+              const TRANSFER &                            transfer,
+              OtherVectorType &                           dst,
+              const OtherVectorType &                     src,
+              const bool                          uses_dof_handler_vector,
+              const typename dealii::mg::Signals &signals,
+              int)
     {
       signals.transfer_to_mg(true);
       if (uses_dof_handler_vector)
@@ -804,15 +801,14 @@ namespace internal
               class TRANSFER,
               typename OtherVectorType>
     void
-    vmult_add(
-      const std::vector<const dealii::DoFHandler<dim> *> &dof_handler_vector,
-      dealii::Multigrid<VectorType> &                     multigrid,
-      const TRANSFER &                                    transfer,
-      OtherVectorType &                                   dst,
-      const OtherVectorType &                             src,
-      const bool                          uses_dof_handler_vector,
-      const typename dealii::mg::Signals &signals,
-      ...)
+    vmult_add(const std::vector<const DoFHandler<dim> *> &dof_handler_vector,
+              dealii::Multigrid<VectorType> &             multigrid,
+              const TRANSFER &                            transfer,
+              OtherVectorType &                           dst,
+              const OtherVectorType &                     src,
+              const bool                          uses_dof_handler_vector,
+              const typename dealii::mg::Signals &signals,
+              ...)
     {
       (void)uses_dof_handler_vector;
       Assert(!uses_dof_handler_vector, ExcInternalError());
index 1a5d334317ef4b3671a2e396a57155bc23d1bf6f..c9edbc28563ee92c5188af533799b690c4176e2c 100644 (file)
@@ -611,7 +611,7 @@ namespace VectorTools
                            concepts::is_writable_dealii_vector_type<OutVector>)
   void integrate_difference(
     const dealii::hp::MappingCollection<dim, spacedim> &     mapping,
-    const dealii::DoFHandler<dim, spacedim> &                dof,
+    const DoFHandler<dim, spacedim> &                        dof,
     const InVector &                                         fe_function,
     const Function<spacedim, typename InVector::value_type> &exact_solution,
     OutVector &                                              difference,
@@ -635,7 +635,7 @@ namespace VectorTools
   DEAL_II_CXX20_REQUIRES(concepts::is_dealii_vector_type<InVector> &&
                            concepts::is_writable_dealii_vector_type<OutVector>)
   void integrate_difference(
-    const dealii::DoFHandler<dim, spacedim> &                dof,
+    const DoFHandler<dim, spacedim> &                        dof,
     const InVector &                                         fe_function,
     const Function<spacedim, typename InVector::value_type> &exact_solution,
     OutVector &                                              difference,
index e50589df0261578a8abc955b3b4ca6306995ae8e..138e768e8cec3affccbe268df0292a77d1766700 100644 (file)
@@ -27,8 +27,8 @@ namespace parallel
 {
   template <int dim, int spacedim>
   CellWeights<dim, spacedim>::CellWeights(
-    const dealii::DoFHandler<dim, spacedim> &dof_handler,
-    const WeightingFunction &                weighting_function)
+    const DoFHandler<dim, spacedim> &dof_handler,
+    const WeightingFunction &        weighting_function)
   {
     reinit(dof_handler, weighting_function);
   }
index 62fc1523eaeec2ee63e01767a0f4b817e102a3e0..aea600a6043527a9cf40a25a457c08449ed7064a 100644 (file)
@@ -1061,10 +1061,10 @@ namespace internal
          */
         template <int spacedim>
         static void
-        reserve_space(dealii::DoFHandler<1, spacedim> &dof_handler)
+        reserve_space(DoFHandler<1, spacedim> &dof_handler)
         {
           Assert(dof_handler.fe_collection.size() > 0,
-                 (typename dealii::DoFHandler<1, spacedim>::ExcNoFESelected()));
+                 (typename DoFHandler<1, spacedim>::ExcNoFESelected()));
           Assert(dof_handler.tria->n_levels() > 0,
                  ExcMessage("The current Triangulation must not be empty."));
           Assert(dof_handler.tria->n_levels() ==
@@ -1086,10 +1086,10 @@ namespace internal
 
         template <int spacedim>
         static void
-        reserve_space(dealii::DoFHandler<2, spacedim> &dof_handler)
+        reserve_space(DoFHandler<2, spacedim> &dof_handler)
         {
           Assert(dof_handler.fe_collection.size() > 0,
-                 (typename dealii::DoFHandler<1, spacedim>::ExcNoFESelected()));
+                 (typename DoFHandler<1, spacedim>::ExcNoFESelected()));
           Assert(dof_handler.tria->n_levels() > 0,
                  ExcMessage("The current Triangulation must not be empty."));
           Assert(dof_handler.tria->n_levels() ==
@@ -1113,10 +1113,10 @@ namespace internal
 
         template <int spacedim>
         static void
-        reserve_space(dealii::DoFHandler<3, spacedim> &dof_handler)
+        reserve_space(DoFHandler<3, spacedim> &dof_handler)
         {
           Assert(dof_handler.fe_collection.size() > 0,
-                 (typename dealii::DoFHandler<1, spacedim>::ExcNoFESelected()));
+                 (typename DoFHandler<1, spacedim>::ExcNoFESelected()));
           Assert(dof_handler.tria->n_levels() > 0,
                  ExcMessage("The current Triangulation must not be empty."));
           Assert(dof_handler.tria->n_levels() ==
@@ -1328,15 +1328,18 @@ namespace internal
               // to have functions that can pack and unpack the data we want to
               // transport -- namely, the single unsigned int active_fe_index
               // objects
-              auto pack = [](const typename dealii::DoFHandler<dim, spacedim>::
-                               active_cell_iterator &cell) -> types::fe_index {
+              auto pack =
+                [](
+                  const typename DoFHandler<dim, spacedim>::active_cell_iterator
+                    &cell) -> types::fe_index {
                 return cell->active_fe_index();
               };
 
-              auto unpack = [&dof_handler](
-                              const typename dealii::DoFHandler<dim, spacedim>::
-                                active_cell_iterator &cell,
-                              const types::fe_index   active_fe_index) -> void {
+              auto unpack =
+                [&dof_handler](
+                  const typename DoFHandler<dim, spacedim>::active_cell_iterator
+                    &                   cell,
+                  const types::fe_index active_fe_index) -> void {
                 // we would like to say
                 //   cell->set_active_fe_index(active_fe_index);
                 // but this is not allowed on cells that are not
@@ -1348,7 +1351,7 @@ namespace internal
 
               GridTools::exchange_cell_data_to_ghosts<
                 types::fe_index,
-                dealii::DoFHandler<dim, spacedim>>(dof_handler, pack, unpack);
+                DoFHandler<dim, spacedim>>(dof_handler, pack, unpack);
             }
           else
             {
@@ -1414,17 +1417,19 @@ namespace internal
                            DistributedTriangulationBase<dim, spacedim> *>(
                          &dof_handler.get_triangulation()))
             {
-              auto pack = [&dof_handler](
-                            const typename dealii::DoFHandler<dim, spacedim>::
-                              active_cell_iterator &cell) -> types::fe_index {
+              auto pack =
+                [&dof_handler](
+                  const typename DoFHandler<dim, spacedim>::active_cell_iterator
+                    &cell) -> types::fe_index {
                 return dof_handler
                   .hp_cell_future_fe_indices[cell->level()][cell->index()];
               };
 
-              auto unpack = [&dof_handler](
-                              const typename dealii::DoFHandler<dim, spacedim>::
-                                active_cell_iterator &cell,
-                              const types::fe_index   future_fe_index) -> void {
+              auto unpack =
+                [&dof_handler](
+                  const typename DoFHandler<dim, spacedim>::active_cell_iterator
+                    &                   cell,
+                  const types::fe_index future_fe_index) -> void {
                 dof_handler
                   .hp_cell_future_fe_indices[cell->level()][cell->index()] =
                   future_fe_index;
@@ -1432,7 +1437,7 @@ namespace internal
 
               GridTools::exchange_cell_data_to_ghosts<
                 types::fe_index,
-                dealii::DoFHandler<dim, spacedim>>(dof_handler, pack, unpack);
+                DoFHandler<dim, spacedim>>(dof_handler, pack, unpack);
             }
           else
             {
index c05d87f198c3f4f62e3269043329efa4a990b01a..bba45eca09c43440af2f8cf985d9a1a943ad0b9e 100644 (file)
@@ -50,10 +50,10 @@ namespace internal
   {
     namespace Policy
     {
-      // use class dealii::DoFHandler instead
+      // use class DoFHandler instead
       // of namespace internal::DoFHandler in
       // the following
-      using dealii::DoFHandler;
+      using DoFHandler;
 
       namespace
       {
index 6b5713d87001afad5a0e5ee81a6fc3733978e5a6..6a676b6bb4887076c8b11fbee5ebe7921b830de3 100644 (file)
@@ -901,8 +901,7 @@ namespace DoFTools
     {
       template <int spacedim>
       IndexSet
-      extract_hanging_node_dofs(
-        const dealii::DoFHandler<1, spacedim> &dof_handler)
+      extract_hanging_node_dofs(const DoFHandler<1, spacedim> &dof_handler)
       {
         // there are no hanging nodes in 1d
         return IndexSet(dof_handler.n_dofs());
@@ -911,8 +910,7 @@ namespace DoFTools
 
       template <int spacedim>
       IndexSet
-      extract_hanging_node_dofs(
-        const dealii::DoFHandler<2, spacedim> &dof_handler)
+      extract_hanging_node_dofs(const DoFHandler<2, spacedim> &dof_handler)
       {
         const unsigned int dim = 2;
 
@@ -928,8 +926,7 @@ namespace DoFTools
               for (const unsigned int face : cell->face_indices())
                 if (cell->face(face)->has_children())
                   {
-                    const typename dealii::DoFHandler<dim,
-                                                      spacedim>::line_iterator
+                    const typename DoFHandler<dim, spacedim>::line_iterator
                       line = cell->face(face);
 
                     for (unsigned int dof = 0; dof != fe.n_dofs_per_vertex();
@@ -957,8 +954,7 @@ namespace DoFTools
 
       template <int spacedim>
       IndexSet
-      extract_hanging_node_dofs(
-        const dealii::DoFHandler<3, spacedim> &dof_handler)
+      extract_hanging_node_dofs(const DoFHandler<3, spacedim> &dof_handler)
       {
         const unsigned int dim = 3;
 
@@ -971,8 +967,8 @@ namespace DoFTools
           if (!cell->is_artificial())
             for (auto f : cell->face_indices())
               {
-                const typename dealii::DoFHandler<dim, spacedim>::face_iterator
-                  face = cell->face(f);
+                const typename DoFHandler<dim, spacedim>::face_iterator face =
+                  cell->face(f);
                 if (cell->face(f)->has_children())
                   {
                     for (unsigned int child = 0; child < 4; ++child)
index 1823435b49a4c2854bce6e365b5419232f7f2c8d..3fa84bc11e339557d498be98fd53dad117e594e0 100644 (file)
@@ -577,7 +577,7 @@ namespace DoFTools
 
     template <typename number>
     void
-    make_hp_hanging_node_constraints(const dealii::DoFHandler<1> &,
+    make_hp_hanging_node_constraints(const DoFHandler<1> &,
                                      AffineConstraints<number> &)
     {
       // nothing to do for regular dof handlers in 1d
@@ -586,7 +586,7 @@ namespace DoFTools
 
     template <typename number>
     void
-    make_oldstyle_hanging_node_constraints(const dealii::DoFHandler<1> &,
+    make_oldstyle_hanging_node_constraints(const DoFHandler<1> &,
                                            AffineConstraints<number> &,
                                            std::integral_constant<int, 1>)
     {
@@ -596,7 +596,7 @@ namespace DoFTools
 
     template <typename number>
     void
-    make_hp_hanging_node_constraints(const dealii::DoFHandler<1, 2> &,
+    make_hp_hanging_node_constraints(const DoFHandler<1, 2> &,
                                      AffineConstraints<number> &)
     {
       // nothing to do for regular dof handlers in 1d
@@ -605,7 +605,7 @@ namespace DoFTools
 
     template <typename number>
     void
-    make_oldstyle_hanging_node_constraints(const dealii::DoFHandler<1, 2> &,
+    make_oldstyle_hanging_node_constraints(const DoFHandler<1, 2> &,
                                            AffineConstraints<number> &,
                                            std::integral_constant<int, 1>)
     {
@@ -616,7 +616,7 @@ namespace DoFTools
     template <typename number, int spacedim>
     void
     make_hp_hanging_node_constraints(
-      const dealii::DoFHandler<1, spacedim> & /*dof_handler*/,
+      const DoFHandler<1, spacedim> & /*dof_handler*/,
       AffineConstraints<number> & /*constraints*/)
     {
       // nothing to do for dof handlers in 1d
@@ -626,7 +626,7 @@ namespace DoFTools
     template <typename number, int spacedim>
     void
     make_oldstyle_hanging_node_constraints(
-      const dealii::DoFHandler<1, spacedim> & /*dof_handler*/,
+      const DoFHandler<1, spacedim> & /*dof_handler*/,
       AffineConstraints<number> & /*constraints*/,
       std::integral_constant<int, 1>)
     {
@@ -2678,15 +2678,13 @@ namespace DoFTools
       template <int dim, int spacedim>
       void
       compute_intergrid_weights_3(
-        const typename dealii::DoFHandler<dim, spacedim>::active_cell_iterator
-          &cell,
+        const typename DoFHandler<dim, spacedim>::active_cell_iterator &cell,
         const Assembler::Scratch &,
-        Assembler::CopyData<dim, spacedim> &copy_data,
-        const unsigned int                  coarse_component,
-        const FiniteElement<dim, spacedim> &coarse_fe,
-        const InterGridMap<dealii::DoFHandler<dim, spacedim>>
-          &                                        coarse_to_fine_grid_map,
-        const std::vector<dealii::Vector<double>> &parameter_dofs)
+        Assembler::CopyData<dim, spacedim> &           copy_data,
+        const unsigned int                             coarse_component,
+        const FiniteElement<dim, spacedim> &           coarse_fe,
+        const InterGridMap<DoFHandler<dim, spacedim>> &coarse_to_fine_grid_map,
+        const std::vector<dealii::Vector<double>> &    parameter_dofs)
       {
         // for each cell on the parameter grid: find out which degrees of
         // freedom on the fine grid correspond in which way to the degrees of
@@ -2847,12 +2845,11 @@ namespace DoFTools
       template <int dim, int spacedim>
       void
       compute_intergrid_weights_2(
-        const dealii::DoFHandler<dim, spacedim> &coarse_grid,
-        const unsigned int                       coarse_component,
-        const InterGridMap<dealii::DoFHandler<dim, spacedim>>
-          &                                         coarse_to_fine_grid_map,
-        const std::vector<dealii::Vector<double>> & parameter_dofs,
-        const std::vector<types::global_dof_index> &weight_mapping,
+        const DoFHandler<dim, spacedim> &              coarse_grid,
+        const unsigned int                             coarse_component,
+        const InterGridMap<DoFHandler<dim, spacedim>> &coarse_to_fine_grid_map,
+        const std::vector<dealii::Vector<double>> &    parameter_dofs,
+        const std::vector<types::global_dof_index> &   weight_mapping,
         std::vector<std::map<types::global_dof_index, float>> &weights)
       {
         Assembler::Scratch                 scratch;
@@ -2912,10 +2909,11 @@ namespace DoFTools
           [coarse_component,
            &coarse_grid,
            &coarse_to_fine_grid_map,
-           &parameter_dofs](const typename dealii::DoFHandler<dim, spacedim>::
-                              active_cell_iterator &            cell,
-                            const Assembler::Scratch &          scratch_data,
-                            Assembler::CopyData<dim, spacedim> &copy_data) {
+           &parameter_dofs](
+            const typename DoFHandler<dim, spacedim>::active_cell_iterator
+              &                                 cell,
+            const Assembler::Scratch &          scratch_data,
+            Assembler::CopyData<dim, spacedim> &copy_data) {
             compute_intergrid_weights_3<dim, spacedim>(cell,
                                                        scratch_data,
                                                        copy_data,
@@ -2964,12 +2962,11 @@ namespace DoFTools
       template <int dim, int spacedim>
       unsigned int
       compute_intergrid_weights_1(
-        const dealii::DoFHandler<dim, spacedim> &coarse_grid,
-        const unsigned int                       coarse_component,
-        const dealii::DoFHandler<dim, spacedim> &fine_grid,
-        const unsigned int                       fine_component,
-        const InterGridMap<dealii::DoFHandler<dim, spacedim>>
-          &coarse_to_fine_grid_map,
+        const DoFHandler<dim, spacedim> &              coarse_grid,
+        const unsigned int                             coarse_component,
+        const DoFHandler<dim, spacedim> &              fine_grid,
+        const unsigned int                             fine_component,
+        const InterGridMap<DoFHandler<dim, spacedim>> &coarse_to_fine_grid_map,
         std::vector<std::map<types::global_dof_index, float>> &weights,
         std::vector<types::global_dof_index> &                 weight_mapping)
       {
index 9309e9edd29470d929638168c71a0af3d4dcca9b..268395e1384ea213c759c7cb24d2f8a54f0101db 100644 (file)
@@ -1185,8 +1185,7 @@ namespace DoFTools
                   // Loop over interior faces
                   for (const unsigned int face : cell->face_indices())
                     {
-                      const typename dealii::DoFHandler<dim,
-                                                        spacedim>::face_iterator
+                      const typename DoFHandler<dim, spacedim>::face_iterator
                         cell_face = cell->face(face);
 
                       const bool periodic_neighbor =
@@ -1194,8 +1193,9 @@ namespace DoFTools
 
                       if ((!cell->at_boundary(face)) || periodic_neighbor)
                         {
-                          typename dealii::DoFHandler<dim, spacedim>::
-                            level_cell_iterator neighbor =
+                          typename DoFHandler<dim,
+                                              spacedim>::level_cell_iterator
+                            neighbor =
                               cell->neighbor_or_periodic_neighbor(face);
 
                           // Like the non-hp-case: If the cells are on the same
@@ -1247,8 +1247,7 @@ namespace DoFTools
                                    sub_nr != cell_face->n_children();
                                    ++sub_nr)
                                 {
-                                  const typename dealii::DoFHandler<dim,
-                                                                    spacedim>::
+                                  const typename DoFHandler<dim, spacedim>::
                                     level_cell_iterator sub_neighbor =
                                       periodic_neighbor ?
                                         cell
index ea8d8872045e284b14d3df90abc1bb34ae456f32..10aa025bcceb0a5244245819901ee6bf198377fa 100644 (file)
@@ -117,7 +117,7 @@ namespace internal
             tr.begin_active()->set_refine_flag(RefinementCase<dim>(ref_case));
             tr.execute_coarsening_and_refinement();
 
-            dealii::DoFHandler<dim, spacedim> dh(tr);
+            DoFHandler<dim, spacedim> dh(tr);
             dh.distribute_dofs(fe);
 
             dealii::FEValues<dim, spacedim> fine(get_default_linear_mapping(tr),
@@ -136,8 +136,8 @@ namespace internal
               nc, std::vector<types::global_dof_index>(fe.n_dofs_per_cell()));
 
             // now create the mass matrix and all the right_hand sides
-            unsigned int                                           child_no = 0;
-            typename dealii::DoFHandler<dim>::active_cell_iterator cell =
+            unsigned int                                   child_no = 0;
+            typename DoFHandler<dim>::active_cell_iterator cell =
               dh.begin_active();
             for (; cell != dh.end(); ++cell, ++child_no)
               {
index 25b422a3c2f3e5c2548b7e7fb69e1d6520ced045..9e144c913cb8d8a74d4209a43665d2ae9bbf616f 100644 (file)
@@ -1265,7 +1265,7 @@ namespace GridTools
 
 
   template <int dim, int spacedim>
-  std::pair<typename dealii::DoFHandler<dim, spacedim>::active_cell_iterator,
+  std::pair<typename DoFHandler<dim, spacedim>::active_cell_iterator,
             Point<dim>>
   find_active_cell_around_point(
     const hp::MappingCollection<dim, spacedim> &mapping,
@@ -1280,7 +1280,7 @@ namespace GridTools
                       "the FECollection."));
 
     using cell_iterator =
-      typename dealii::DoFHandler<dim, spacedim>::active_cell_iterator;
+      typename DoFHandler<dim, spacedim>::active_cell_iterator;
 
     std::pair<cell_iterator, Point<dim>> best_cell;
     // If we have only one element in the MappingCollection,
@@ -1384,7 +1384,7 @@ namespace GridTools
             if (!found && cells_searched < n_cells)
               {
                 find_active_cell_around_point_internal<dim,
-                                                       dealii::DoFHandler,
+                                                       DoFHandler,
                                                        spacedim>(
                   mesh, searched_cells, adjacent_cells);
               }
index c8f198d660a0b63f46f964e06bbb59130e950866..5d8872462caf6f3adf7fd291a32a85100b317dca 100644 (file)
@@ -154,8 +154,8 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS)
     \{
 
       template std::pair<
-        dealii::DoFHandler<deal_II_dimension,
-                           deal_II_space_dimension>::active_cell_iterator,
+        DoFHandler<deal_II_dimension,
+                   deal_II_space_dimension>::active_cell_iterator,
         Point<deal_II_dimension>>
       find_active_cell_around_point(
         const hp::MappingCollection<deal_II_dimension, deal_II_space_dimension>
index e780f11ff601d47f476ca9c0058ce0b405d81651..c9bebf2b0f99ff14bba66b46beb11bf1d80a0566 100644 (file)
@@ -52,7 +52,7 @@ namespace
   template <int dim, typename number, int spacedim>
   void
   reinit_vector_by_blocks(
-    const dealii::DoFHandler<dim, spacedim> &          dof_handler,
+    const DoFHandler<dim, spacedim> &                  dof_handler,
     MGLevelObject<BlockVector<number>> &               v,
     const std::vector<bool> &                          sel,
     std::vector<std::vector<types::global_dof_index>> &ndofs)
@@ -98,7 +98,7 @@ namespace
   template <int dim, typename number, int spacedim>
   void
   reinit_vector_by_blocks(
-    const dealii::DoFHandler<dim, spacedim> &          dof_handler,
+    const DoFHandler<dim, spacedim> &                  dof_handler,
     MGLevelObject<dealii::Vector<number>> &            v,
     const unsigned int                                 selected_block,
     std::vector<std::vector<types::global_dof_index>> &ndofs)
index 3c76f557ab2e25d9193537b2974904d1f216265b..60a12ce2f3bc40f9c10ce062e5d8aaacbd137952 100644 (file)
@@ -79,7 +79,7 @@ namespace
   template <int dim, typename number, int spacedim>
   void
   reinit_vector_by_components(
-    const dealii::DoFHandler<dim, spacedim> &          mg_dof,
+    const DoFHandler<dim, spacedim> &                  mg_dof,
     MGLevelObject<BlockVector<number>> &               v,
     const std::vector<bool> &                          sel,
     const std::vector<unsigned int> &                  target_comp,
@@ -178,7 +178,7 @@ namespace
   template <int dim, typename number, int spacedim>
   void
   reinit_vector_by_components(
-    const dealii::DoFHandler<dim, spacedim> &          mg_dof,
+    const DoFHandler<dim, spacedim> &                  mg_dof,
     MGLevelObject<dealii::Vector<number>> &            v,
     const ComponentMask &                              component_mask,
     const std::vector<unsigned int> &                  target_component,
index 4a4339de14c619d10a01abf088ba746f402df463..92180ed276232528e6b044b5f7f8f81cbc40d7f8 100644 (file)
@@ -59,8 +59,8 @@ namespace internal
     template <int dim, int spacedim>
     void
     fill_copy_indices(
-      const dealii::DoFHandler<dim, spacedim> &dof_handler,
-      const MGConstrainedDoFs *                mg_constrained_dofs,
+      const DoFHandler<dim, spacedim> &dof_handler,
+      const MGConstrainedDoFs *        mg_constrained_dofs,
       std::vector<std::vector<
         std::pair<types::global_dof_index, types::global_dof_index>>>
         &copy_indices,
@@ -552,9 +552,9 @@ namespace internal
 
     template <int dim, typename Number>
     void
-    setup_element_info(ElementInfo<Number> &          elem_info,
-                       const FiniteElement<1> &       fe,
-                       const dealii::DoFHandler<dim> &dof_handler)
+    setup_element_info(ElementInfo<Number> &   elem_info,
+                       const FiniteElement<1> &fe,
+                       const DoFHandler<dim> & dof_handler)
     {
       // currently, we have only FE_Q and FE_DGQ type elements implemented
       elem_info.n_components = dof_handler.get_fe().element_multiplicity(0);
@@ -617,8 +617,8 @@ namespace internal
     template <int dim, typename Number>
     void
     setup_transfer(
-      const dealii::DoFHandler<dim> &dof_handler,
-      const MGConstrainedDoFs *      mg_constrained_dofs,
+      const DoFHandler<dim> &  dof_handler,
+      const MGConstrainedDoFs *mg_constrained_dofs,
       const std::vector<std::shared_ptr<const Utilities::MPI::Partitioner>>
         &                                     external_partitioners,
       ElementInfo<Number> &                   elem_info,
@@ -692,7 +692,7 @@ namespace internal
           std::vector<types::global_dof_index> ghosted_level_dofs_l0;
 
           // step 2.1: loop over the cells on the coarse side
-          typename dealii::DoFHandler<dim>::cell_iterator cell,
+          typename DoFHandler<dim>::cell_iterator cell,
             endc = dof_handler.end(level - 1);
           for (cell = dof_handler.begin(level - 1); cell != endc; ++cell)
             {
index eb4385980ed98ce53f7a046356367dbc5616fe33..1d69d57f7c300632ee9f0bdc32a58cbd2cceeac0 100644 (file)
@@ -25,8 +25,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS)
 #if deal_II_dimension <= deal_II_space_dimension
         template void
         fill_copy_indices<deal_II_dimension, deal_II_space_dimension>(
-          const dealii::DoFHandler<deal_II_dimension, deal_II_space_dimension>
-            &,
+          const DoFHandler<deal_II_dimension, deal_II_space_dimension> &,
           const MGConstrainedDoFs *,
           std::vector<std::vector<
             std::pair<types::global_dof_index, types::global_dof_index>>> &,
@@ -77,7 +76,7 @@ for (deal_II_dimension : DIMENSIONS; S : REAL_SCALARS)
 
         template void
         setup_transfer<deal_II_dimension>(
-          const dealii::DoFHandler<deal_II_dimension> &,
+          const DoFHandler<deal_II_dimension> &,
           const MGConstrainedDoFs *,
           const std::vector<std::shared_ptr<const Utilities::MPI::Partitioner>>
             &,
index a22805f9eda16f92c7e22cf415624eed667f0720..0d98c900991de3f80ccb77472d485bf483c734ad 100644 (file)
@@ -217,7 +217,7 @@ namespace internal
    */
   template <int dim, int spacedim>
   void
-  extract_interpolation_matrices(const dealii::DoFHandler<dim, spacedim> &dof,
+  extract_interpolation_matrices(const DoFHandler<dim, spacedim> &     dof,
                                  dealii::Table<2, FullMatrix<double>> &matrices)
   {
     if (dof.has_hp_capabilities() == false)

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.