]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Rename parallel::Triangulation to parallel::TriangulationBase 8600/head
authorPeter Munch <peterrmuench@gmail.com>
Mon, 19 Aug 2019 06:33:59 +0000 (08:33 +0200)
committerPeter Munch <peterrmuench@gmail.com>
Mon, 19 Aug 2019 17:52:01 +0000 (19:52 +0200)
40 files changed:
doc/news/changes/incompatibilities/20190819PeterMunch [new file with mode: 0644]
include/deal.II/distributed/cell_weights.h
include/deal.II/distributed/shared_tria.h
include/deal.II/distributed/tria.h
include/deal.II/distributed/tria_base.h
include/deal.II/dofs/dof_handler.h
include/deal.II/dofs/dof_renumbering.h
include/deal.II/dofs/dof_tools.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/grid_tools_cache.h
include/deal.II/grid/tria_accessor.templates.h
include/deal.II/hp/dof_handler.h
include/deal.II/matrix_free/cuda_matrix_free.templates.h
include/deal.II/matrix_free/face_setup_internal.h
include/deal.II/matrix_free/matrix_free.templates.h
include/deal.II/multigrid/mg_transfer.h
include/deal.II/multigrid/mg_transfer.templates.h
include/deal.II/multigrid/mg_transfer_matrix_free.h
include/deal.II/numerics/vector_tools.h
include/deal.II/numerics/vector_tools.templates.h
source/distributed/cell_weights.cc
source/distributed/shared_tria.cc
source/distributed/tria.cc
source/distributed/tria_base.cc
source/distributed/tria_base.inst.in
source/dofs/dof_handler_policy.cc
source/dofs/dof_renumbering.cc
source/dofs/dof_tools.cc
source/dofs/dof_tools_constraints.cc
source/dofs/dof_tools_sparsity.cc
source/grid/grid_out.cc
source/grid/grid_tools.cc
source/grid/grid_tools_cache.cc
source/hp/dof_handler.cc
source/hp/refinement.cc
source/multigrid/mg_level_global_transfer.cc
source/multigrid/mg_tools.cc
source/multigrid/mg_transfer_internal.cc
source/multigrid/mg_transfer_prebuilt.cc
source/non_matching/coupling.cc

diff --git a/doc/news/changes/incompatibilities/20190819PeterMunch b/doc/news/changes/incompatibilities/20190819PeterMunch
new file mode 100644 (file)
index 0000000..1eed903
--- /dev/null
@@ -0,0 +1,5 @@
+Changed: The parallel::Triangulation class has been renamed to parallel::TriangulationBase
+to better reflect its purpose of a base to a series of parallel triangulations such as
+parallel::distributed::Triangulation or parallel::shared::Triangulation.
+<br>
+(Peter Munch, 2019/08/19)
index eecd4c69bddcef4b8da54bc3a17a6e3f0036f218..05eaae20d7aef7f005c9430bd9f7833b4396fc46 100644 (file)
@@ -28,7 +28,7 @@ DEAL_II_NAMESPACE_OPEN
 namespace parallel
 {
   /**
-   * Anytime a parallel::Triangulation is repartitioned, either upon request
+   * Anytime a parallel::TriangulationBase is repartitioned, either upon request
    * or by refinement/coarsening, cells will be distributed amongst all
    * subdomains to achieve an equally balanced workload. If the workload per
    * cell varies, which is in general the case for hp::DoFHandler objects, we
@@ -40,7 +40,7 @@ namespace parallel
    * a hp::DoFHandler. One can choose from predefined weighting
    * algorithms provided by this class or provide a custom one. The
    * chosen weighting function will be connected to the corresponding
-   * signal of the linked parallel::Triangulation via callback.
+   * signal of the linked parallel::TriangulationBase via callback.
    *
    * An object of this class needs to exist for every DoFHandler associated
    * with the Triangulation we work on to achieve satisfying work balancing
@@ -147,7 +147,7 @@ namespace parallel
      * We store both to make sure to always work on the correct combination of
      * both.
      */
-    SmartPointer<const parallel::Triangulation<dim, spacedim>, CellWeights>
+    SmartPointer<const parallel::TriangulationBase<dim, spacedim>, CellWeights>
       triangulation;
 
     /**
index 66af85cf51905a1f5c9c73d7cb5d61d350519961..364dcf1286b81d1249fc348a496e22b4a425b4d5 100644 (file)
@@ -99,7 +99,8 @@ namespace parallel
      *
      */
     template <int dim, int spacedim = dim>
-    class Triangulation : public dealii::parallel::Triangulation<dim, spacedim>
+    class Triangulation
+      : public dealii::parallel::TriangulationBase<dim, spacedim>
     {
     public:
       using active_cell_iterator =
@@ -401,7 +402,8 @@ namespace parallel
      * MPI is not available.
      */
     template <int dim, int spacedim = dim>
-    class Triangulation : public dealii::parallel::Triangulation<dim, spacedim>
+    class Triangulation
+      : public dealii::parallel::TriangulationBase<dim, spacedim>
     {
     public:
       /**
index 539a866608d2409586a88ba3b0d06aec353e73e8..4c4b9b0b64591e794fedf22897c449493c353391 100644 (file)
@@ -154,7 +154,7 @@ namespace parallel
      * and this function needs to know about boundaries. In other words, it is
      * <i>not</i> enough to just set boundary indicators on newly created
      * faces only <i>after</i> calling
-     * <tt>distributed::parallel::Triangulation::execute_coarsening_and_refinement</tt>:
+     * <tt>distributed::parallel::TriangulationBase::execute_coarsening_and_refinement</tt>:
      * it actually has to happen while that function is still running.
      *
      * The way to do this is by writing a function that sets boundary
@@ -248,7 +248,8 @@ namespace parallel
      * @ingroup distributed
      */
     template <int dim, int spacedim = dim>
-    class Triangulation : public dealii::parallel::Triangulation<dim, spacedim>
+    class Triangulation
+      : public dealii::parallel::TriangulationBase<dim, spacedim>
     {
     public:
       /**
@@ -1199,7 +1200,7 @@ namespace parallel
       get_cell_weights() const;
 
       /**
-       * Override the implementation in parallel::Triangulation because
+       * Override the implementation in parallel::TriangulationBase because
        * we can ask p4est about ghost neighbors across periodic boundaries.
        *
        * Specifically, this function determines the neighboring subdomains that
@@ -1236,7 +1237,7 @@ namespace parallel
      */
     template <int spacedim>
     class Triangulation<1, spacedim>
-      : public dealii::parallel::Triangulation<1, spacedim>
+      : public dealii::parallel::TriangulationBase<1, spacedim>
     {
     public:
       /**
@@ -1410,7 +1411,8 @@ namespace parallel
      * p4est is not available.
      */
     template <int dim, int spacedim = dim>
-    class Triangulation : public dealii::parallel::Triangulation<dim, spacedim>
+    class Triangulation
+      : public dealii::parallel::TriangulationBase<dim, spacedim>
     {
     public:
       /**
index 1b450a4022f32121a31003f8358060bba728cee3..09f5fa3e3ac0f8e00104679dd2b1ed26c9c7866d 100644 (file)
@@ -44,13 +44,13 @@ namespace parallel
    * parallel::shared::Triangulation.
    */
   template <int dim, int spacedim = dim>
-  class Triangulation : public dealii::Triangulation<dim, spacedim>
+  class TriangulationBase : public dealii::Triangulation<dim, spacedim>
   {
   public:
     /**
      * Constructor.
      */
-    Triangulation(
+    TriangulationBase(
       MPI_Comm mpi_communicator,
       const typename dealii::Triangulation<dim, spacedim>::MeshSmoothing
                  smooth_grid = (dealii::Triangulation<dim, spacedim>::none),
@@ -59,7 +59,7 @@ namespace parallel
     /**
      * Destructor.
      */
-    virtual ~Triangulation() override;
+    virtual ~TriangulationBase() override;
 
     /**
      * Return MPI communicator used by this triangulation.
@@ -239,6 +239,13 @@ namespace parallel
     fill_level_ghost_owners();
   };
 
+  /**
+   *  Using directive for backwards-compatibility.
+   *  @deprecated Use TriangulationBase instead of Triangulation.
+   */
+  template <int dim, int spacedim = dim>
+  using Triangulation DEAL_II_DEPRECATED = TriangulationBase<dim, spacedim>;
+
 } // namespace parallel
 
 DEAL_II_NAMESPACE_CLOSE
index 438d5bff9186c5070c98061dfe6efb6badb97ab3..de66e8d9b443874aadacfd3d467ee371008695e9 100644 (file)
@@ -1586,8 +1586,8 @@ template <int dim, int spacedim>
 std::vector<types::global_dof_index>
 DoFHandler<dim, spacedim>::compute_n_locally_owned_dofs_per_processor() const
 {
-  const parallel::Triangulation<dim, spacedim> *tr =
-    (dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+  const parallel::TriangulationBase<dim, spacedim> *tr =
+    (dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
       &this->get_triangulation()));
   if (tr != nullptr)
     return number_cache.get_n_locally_owned_dofs_per_processor(
@@ -1602,8 +1602,8 @@ template <int dim, int spacedim>
 std::vector<IndexSet>
 DoFHandler<dim, spacedim>::compute_locally_owned_dofs_per_processor() const
 {
-  const parallel::Triangulation<dim, spacedim> *tr =
-    (dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+  const parallel::TriangulationBase<dim, spacedim> *tr =
+    (dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
       &this->get_triangulation()));
   if (tr != nullptr)
     return number_cache.get_locally_owned_dofs_per_processor(
@@ -1626,8 +1626,8 @@ DoFHandler<dim, spacedim>::compute_locally_owned_mg_dofs_per_processor(
     mg_number_cache.size() == this->get_triangulation().n_global_levels(),
     ExcMessage(
       "The level dofs are not set up properly! Did you call distribute_mg_dofs()?"));
-  const parallel::Triangulation<dim, spacedim> *tr =
-    (dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+  const parallel::TriangulationBase<dim, spacedim> *tr =
+    (dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
       &this->get_triangulation()));
   if (tr != nullptr)
     return mg_number_cache[level].get_locally_owned_dofs_per_processor(
index 4a8d1d8117f089ac97f537465453cf449e17a237..3a94d4e8c1e58d8f916c4c048ba69778f7b9dc0c 100644 (file)
@@ -855,7 +855,8 @@ namespace DoFRenumbering
    * @pre for serial triangulation @p cell_order must have size
    * <code>dof_handler.get_triangulation().n_active_cells()</code>, whereas
    * in case of parallel triangulation its size should be
-   * parallel::Triangulation::n_locally_owned_active_cells(). Every active cell
+   * parallel::TriangulationBase::n_locally_owned_active_cells(). Every active
+   * cell
    * iterator of that triangulation needs to be present in @p cell_order exactly
    * once.
    */
@@ -883,8 +884,8 @@ namespace DoFRenumbering
    * vector therefore presents a (very particular) <i>permutation</i> of the
    * current DoF indices.
    * @param[out] inverse_renumbering The reverse of the permutation returned
-   * in the previous argument. In case of parallel::Triangulation the inverse
-   * is within locally owned DoFs.
+   * in the previous argument. In case of parallel::TriangulationBase the
+   * inverse is within locally owned DoFs.
    * @param[in] dof_handler The DoFHandler whose degrees of freedom are to be
    * renumbered.
    * @param[in] cell_order A vector that contains the order of the cells that
@@ -893,8 +894,8 @@ namespace DoFRenumbering
    * @pre for serial triangulation @p cell_order must have size
    * <code>dof_handler.get_triangulation().n_active_cells()</code>, whereas
    * in case of parallel triangulation its size should be
-   * parallel::Triangulation::n_locally_owned_active_cells(). Every active cell
-   * iterator of that triangulation needs to be present in @p
+   * parallel::TriangulationBase::n_locally_owned_active_cells(). Every active
+   * cell iterator of that triangulation needs to be present in @p
    * cell_order exactly once. @post For each @p i between zero and
    * <code>dof_handler.n_locally_owned_dofs()</code>, the condition
    * <code>renumbering[inverse_renumbering[i]] ==
index 2dab61a1826b6b328292536d7c31b751c770a6be..fd8c77abbfebe7f1767c2695d652876b19a87bcb 100644 (file)
@@ -1311,7 +1311,7 @@ namespace DoFTools
 
   /**
    * Same as above but return the selected DoFs as IndexSet. In particular,
-   * for parallel::Triangulation objects this function should be preferred.
+   * for parallel::TriangulationBase objects this function should be preferred.
    */
   template <int dim, int spacedim>
   IndexSet
index 39b821443071b7def0a7658ca8fdc08ddfb4d089..81845750cb9b9fe61e9d38ed8d33adfd4eb64d81 100644 (file)
@@ -727,7 +727,7 @@ namespace GridTools
    * distances between them, might make the function extremely faster.
    *
    * @note If a point is not found inside the mesh, or is lying inside an
-   * artificial cell of a parallel::Triangulation, an exception is thrown.
+   * artificial cell of a parallel::TriangulationBase, an exception is thrown.
    *
    * @note The actual return type of this function, i.e., the type referenced
    * above as @p return_type, is
@@ -814,9 +814,9 @@ namespace GridTools
    * @p local_points for each process, find the points lying on the locally
    * owned part of the mesh and compute the quadrature rules for them.
    * Distributed compute point locations is a function similar to
-   * GridTools::compute_point_locations but working for parallel::Triangulation
-   * objects and, unlike its serial version, also for a distributed
-   * triangulation (see parallel::distributed::Triangulation).
+   * GridTools::compute_point_locations but working for
+   * parallel::TriangulationBase objects and, unlike its serial version, also
+   * for a distributed triangulation (see parallel::distributed::Triangulation).
    *
    * @param[in] cache a GridTools::Cache object
    * @param[in] local_points the array of points owned by the current process.
@@ -850,7 +850,7 @@ namespace GridTools
    *
    * The function uses the triangulation's mpi communicator: for this reason it
    * throws an assert error if the Triangulation is not derived from
-   * parallel::Triangulation .
+   * parallel::TriangulationBase .
    *
    * In a serial execution the first three elements of the tuple are the same
    * as in GridTools::compute_point_locations .
@@ -3805,7 +3805,7 @@ namespace GridTools
 #    else
     constexpr int dim      = MeshType::dimension;
     constexpr int spacedim = MeshType::space_dimension;
-    auto tria = static_cast<const parallel::Triangulation<dim, spacedim> *>(
+    auto tria = static_cast<const parallel::TriangulationBase<dim, spacedim> *>(
       &mesh.get_triangulation());
     Assert(
       tria != nullptr,
index 9ad247ce898fc9338495dfeae3e3e9918667fbd7..75204a92a106a050ac1e96a3e3ef0e71d01f8ad9 100644 (file)
@@ -159,7 +159,7 @@ namespace GridTools
      * areas that cover all or parts of the local portion of a
      * parallel triangulation, and an unsigned int representing
      * the process or subdomain that owns these cells.
-     * Given a point on a parallel::Triangulation, this tree
+     * Given a point on a parallel::TriangulationBase, this tree
      * allows to identify one, or few candidate processes, for
      * which the point lies on a locally owned cell.
      *
index 0fadd84d1139d571cd2216165a492638b9a0ff80..59cdaf16da4fac933e9dac45734dbb2a73904b59 100644 (file)
@@ -40,7 +40,7 @@ DEAL_II_NAMESPACE_OPEN
 namespace parallel
 {
   template <int, int>
-  class Triangulation;
+  class TriangulationBase;
 }
 #endif
 
@@ -3569,8 +3569,9 @@ CellAccessor<dim, spacedim>::is_locally_owned() const
   if (is_artificial())
     return false;
 
-  const parallel::Triangulation<dim, spacedim> *pt =
-    dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(this->tria);
+  const parallel::TriangulationBase<dim, spacedim> *pt =
+    dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
+      this->tria);
 
   if (pt == nullptr)
     return true;
@@ -3589,8 +3590,9 @@ CellAccessor<dim, spacedim>::is_locally_owned_on_level() const
   return true;
 #else
 
-  const parallel::Triangulation<dim, spacedim> *pt =
-    dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(this->tria);
+  const parallel::TriangulationBase<dim, spacedim> *pt =
+    dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
+      this->tria);
 
   if (pt == nullptr)
     return true;
@@ -3614,8 +3616,9 @@ CellAccessor<dim, spacedim>::is_ghost() const
   return false;
 #else
 
-  const parallel::Triangulation<dim, spacedim> *pt =
-    dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(this->tria);
+  const parallel::TriangulationBase<dim, spacedim> *pt =
+    dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
+      this->tria);
 
   if (pt == nullptr)
     return false;
@@ -3637,8 +3640,9 @@ CellAccessor<dim, spacedim>::is_artificial() const
   return false;
 #else
 
-  const parallel::Triangulation<dim, spacedim> *pt =
-    dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(this->tria);
+  const parallel::TriangulationBase<dim, spacedim> *pt =
+    dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
+      this->tria);
 
   if (pt == nullptr)
     return false;
index 2adda552910eabf6c9dc5d6543ef40d576c6332b..d6c9b0888f66914fe4e604cdd0144c5d8300d761 100644 (file)
@@ -431,7 +431,7 @@ namespace hp
     /**
      * Assign a hp::FECollection @p fe to this object.
      *
-     * In case a parallel::Triangulation is assigned to this object,
+     * In case a parallel::TriangulationBase is assigned to this object,
      * the active_fe_indices will be exchanged between processors so that
      * each one knows the indices on its own cells and all ghost cells.
      *
@@ -1595,8 +1595,8 @@ namespace hp
   std::vector<types::global_dof_index>
   DoFHandler<dim, spacedim>::compute_n_locally_owned_dofs_per_processor() const
   {
-    const parallel::Triangulation<dim, spacedim> *tr =
-      (dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+    const parallel::TriangulationBase<dim, spacedim> *tr =
+      (dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
         &this->get_triangulation()));
     if (tr != nullptr)
       return number_cache.get_n_locally_owned_dofs_per_processor(
@@ -1611,8 +1611,8 @@ namespace hp
   std::vector<IndexSet>
   DoFHandler<dim, spacedim>::compute_locally_owned_dofs_per_processor() const
   {
-    const parallel::Triangulation<dim, spacedim> *tr =
-      (dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+    const parallel::TriangulationBase<dim, spacedim> *tr =
+      (dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
         &this->get_triangulation()));
     if (tr != nullptr)
       return number_cache.get_locally_owned_dofs_per_processor(
@@ -1673,8 +1673,8 @@ namespace hp
     Assert(level < this->get_triangulation().n_global_levels(),
            ExcMessage("The given level index exceeds the number of levels "
                       "present in the triangulation"));
-    const parallel::Triangulation<dim, spacedim> *tr =
-      (dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+    const parallel::TriangulationBase<dim, spacedim> *tr =
+      (dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
         &this->get_triangulation()));
     if (tr != nullptr)
       return mg_number_cache[level].get_locally_owned_dofs_per_processor(
index b993716d040da07bee025049c911d8a9942b923d..ace2e804f762afe2c9d19f88c0976a3f56fd94be 100644 (file)
@@ -544,7 +544,8 @@ namespace CUDAWrappers
   {
     const auto &triangulation = dof_handler.get_triangulation();
     if (const auto parallel_triangulation =
-          dynamic_cast<const parallel::Triangulation<dim> *>(&triangulation))
+          dynamic_cast<const parallel::TriangulationBase<dim> *>(
+            &triangulation))
       internal_reinit(mapping,
                       dof_handler,
                       constraints,
index 3646ce6ddaae4a585934aac8a40941c8f9735f4f..84c4eed1db46bb503555c2a9c0263593689b03d0 100644 (file)
@@ -195,7 +195,8 @@ namespace internal
       // boundaries as evenly as possible between the processors
       std::map<types::subdomain_id, FaceIdentifier>
         inner_faces_at_proc_boundary;
-      if (dynamic_cast<const parallel::Triangulation<dim> *>(&triangulation))
+      if (dynamic_cast<const parallel::TriangulationBase<dim> *>(
+            &triangulation))
         {
           const types::subdomain_id my_domain =
             triangulation.locally_owned_subdomain();
@@ -289,8 +290,8 @@ namespace internal
               // looking at the length of the lists of faces
 #  if defined(DEAL_II_WITH_MPI) && defined(DEBUG)
               MPI_Comm comm = MPI_COMM_SELF;
-              if (const parallel::Triangulation<dim> *ptria =
-                    dynamic_cast<const parallel::Triangulation<dim> *>(
+              if (const parallel::TriangulationBase<dim> *ptria =
+                    dynamic_cast<const parallel::TriangulationBase<dim> *>(
                       &triangulation))
                 comm = ptria->get_communicator();
 
index 7e0c4ae4a2163500fae5bf6e7f954c0ba18e5d5a..678b8226edaa0ccc7f0f9b433d781217a4a882c5 100644 (file)
@@ -275,8 +275,8 @@ MatrixFree<dim, Number, VectorizedArrayType>::internal_reinit(
       // set variables that are independent of FE
       if (Utilities::MPI::job_supports_mpi() == true)
         {
-          const parallel::Triangulation<dim> *dist_tria =
-            dynamic_cast<const parallel::Triangulation<dim> *>(
+          const parallel::TriangulationBase<dim> *dist_tria =
+            dynamic_cast<const parallel::TriangulationBase<dim> *>(
               &(dof_handler[0]->get_triangulation()));
           task_info.communicator = dist_tria != nullptr ?
                                      dist_tria->get_communicator() :
@@ -444,8 +444,8 @@ MatrixFree<dim, Number, VectorizedArrayType>::internal_reinit(
       // set variables that are independent of FE
       if (Utilities::MPI::job_supports_mpi() == true)
         {
-          const parallel::Triangulation<dim> *dist_tria =
-            dynamic_cast<const parallel::Triangulation<dim> *>(
+          const parallel::TriangulationBase<dim> *dist_tria =
+            dynamic_cast<const parallel::TriangulationBase<dim> *>(
               &(dof_handler[0]->get_triangulation()));
           task_info.communicator = dist_tria != nullptr ?
                                      dist_tria->get_communicator() :
@@ -658,7 +658,7 @@ MatrixFree<dim, Number, VectorizedArrayType>::initialize_dof_handlers(
                                                  end_cell = tria.end(0);
       // For serial Triangulations always take all cells
       const unsigned int subdomain_id =
-        (dynamic_cast<const parallel::Triangulation<dim> *>(
+        (dynamic_cast<const parallel::TriangulationBase<dim> *>(
            &dof_handler[0]->get_triangulation()) != nullptr) ?
           my_pid :
           numbers::invalid_subdomain_id;
@@ -730,7 +730,7 @@ MatrixFree<dim, Number, VectorizedArrayType>::initialize_dof_handlers(
                                               end_cell = dof_handler[0]->end(0);
   // For serial Triangulations always take all cells
   const unsigned int subdomain_id =
-    (dynamic_cast<const parallel::Triangulation<dim> *>(
+    (dynamic_cast<const parallel::TriangulationBase<dim> *>(
        &dof_handler[0]->get_triangulation()) != nullptr) ?
       my_pid :
       numbers::invalid_subdomain_id;
index ce3a9eafee0b702bd3a076798815f90b228cc03c..ba66e59b4ae2278f56b8b23bde64557ab0493c84 100644 (file)
@@ -82,11 +82,11 @@ namespace internal
            const SparsityPatternType &sp,
            DoFHandlerType &           dh)
     {
-      const parallel::Triangulation<DoFHandlerType::dimension,
-                                    DoFHandlerType::space_dimension>
+      const parallel::TriangulationBase<DoFHandlerType::dimension,
+                                        DoFHandlerType::space_dimension>
         *dist_tria = dynamic_cast<
-          const parallel::Triangulation<DoFHandlerType::dimension,
-                                        DoFHandlerType::space_dimension> *>(
+          const parallel::TriangulationBase<DoFHandlerType::dimension,
+                                            DoFHandlerType::space_dimension> *>(
           &(dh.get_triangulation()));
       MPI_Comm communicator =
         dist_tria != nullptr ? dist_tria->get_communicator() : MPI_COMM_SELF;
@@ -115,11 +115,11 @@ namespace internal
            const SparsityPatternType &sp,
            DoFHandlerType &           dh)
     {
-      const parallel::Triangulation<DoFHandlerType::dimension,
-                                    DoFHandlerType::space_dimension>
+      const parallel::TriangulationBase<DoFHandlerType::dimension,
+                                        DoFHandlerType::space_dimension>
         *dist_tria = dynamic_cast<
-          const parallel::Triangulation<DoFHandlerType::dimension,
-                                        DoFHandlerType::space_dimension> *>(
+          const parallel::TriangulationBase<DoFHandlerType::dimension,
+                                            DoFHandlerType::space_dimension> *>(
           &(dh.get_triangulation()));
       MPI_Comm communicator =
         dist_tria != nullptr ? dist_tria->get_communicator() : MPI_COMM_SELF;
@@ -149,11 +149,11 @@ namespace internal
            const SparsityPatternType &sp,
            DoFHandlerType &           dh)
     {
-      const parallel::Triangulation<DoFHandlerType::dimension,
-                                    DoFHandlerType::space_dimension>
+      const parallel::TriangulationBase<DoFHandlerType::dimension,
+                                        DoFHandlerType::space_dimension>
         *dist_tria = dynamic_cast<
-          const parallel::Triangulation<DoFHandlerType::dimension,
-                                        DoFHandlerType::space_dimension> *>(
+          const parallel::TriangulationBase<DoFHandlerType::dimension,
+                                            DoFHandlerType::space_dimension> *>(
           &(dh.get_triangulation()));
       MPI_Comm communicator =
         dist_tria != nullptr ? dist_tria->get_communicator() : MPI_COMM_SELF;
@@ -182,11 +182,11 @@ namespace internal
            const SparsityPatternType &sp,
            DoFHandlerType &           dh)
     {
-      const parallel::Triangulation<DoFHandlerType::dimension,
-                                    DoFHandlerType::space_dimension>
+      const parallel::TriangulationBase<DoFHandlerType::dimension,
+                                        DoFHandlerType::space_dimension>
         *dist_tria = dynamic_cast<
-          const parallel::Triangulation<DoFHandlerType::dimension,
-                                        DoFHandlerType::space_dimension> *>(
+          const parallel::TriangulationBase<DoFHandlerType::dimension,
+                                            DoFHandlerType::space_dimension> *>(
           &(dh.get_triangulation()));
       MPI_Comm communicator =
         dist_tria != nullptr ? dist_tria->get_communicator() : MPI_COMM_SELF;
@@ -244,11 +244,11 @@ namespace internal
            const SparsityPatternType &sp,
            const DoFHandlerType &     dh)
     {
-      const parallel::Triangulation<DoFHandlerType::dimension,
-                                    DoFHandlerType::space_dimension>
+      const parallel::TriangulationBase<DoFHandlerType::dimension,
+                                        DoFHandlerType::space_dimension>
         *dist_tria = dynamic_cast<
-          const parallel::Triangulation<DoFHandlerType::dimension,
-                                        DoFHandlerType::space_dimension> *>(
+          const parallel::TriangulationBase<DoFHandlerType::dimension,
+                                            DoFHandlerType::space_dimension> *>(
           &(dh.get_triangulation()));
       MPI_Comm communicator =
         dist_tria != nullptr ? dist_tria->get_communicator() : MPI_COMM_SELF;
index e4b9f04913ff59dc419ef6808566e8748ecbd04b..62ca7118df78464e24a3a22e264e1d61ecf759a2 100644 (file)
@@ -117,8 +117,8 @@ namespace internal
                   const std::vector<unsigned int> &,
                   MGLevelObject<TrilinosWrappers::MPI::Vector> &v)
     {
-      const dealii::parallel::Triangulation<dim, spacedim> *tria =
-        (dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+      const dealii::parallel::TriangulationBase<dim, spacedim> *tria =
+        (dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
           &mg_dof.get_triangulation()));
       AssertThrow(
         tria != nullptr,
@@ -145,8 +145,8 @@ namespace internal
                   const std::vector<unsigned int> &,
                   MGLevelObject<PETScWrappers::MPI::Vector> &v)
     {
-      const dealii::parallel::Triangulation<dim, spacedim> *tria =
-        (dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+      const dealii::parallel::TriangulationBase<dim, spacedim> *tria =
+        (dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
           &mg_dof.get_triangulation()));
       AssertThrow(
         tria != nullptr,
@@ -444,8 +444,8 @@ MGLevelGlobalTransfer<LinearAlgebra::distributed::Vector<Number>>::copy_to_mg(
           dst[level].reinit(ghosted_level_vector[level], false);
         else
           {
-            const parallel::Triangulation<dim, spacedim> *tria =
-              (dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+            const parallel::TriangulationBase<dim, spacedim> *tria =
+              (dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
                 &mg_dof_handler.get_triangulation()));
             dst[level].reinit(mg_dof_handler.locally_owned_mg_dofs(level),
                               tria != nullptr ? tria->get_communicator() :
index f27c9cb6cbabd310f5f85877f83c3eefa032abec..111ca464bf1de5d861ca8da2da802959a081eac6 100644 (file)
@@ -482,8 +482,8 @@ MGTransferMatrixFree<dim, Number>::interpolate_to_mg(
          ExcDimensionMismatch(
            max_level, dof_handler.get_triangulation().n_global_levels() - 1));
 
-  const parallel::Triangulation<dim, spacedim> *p_tria =
-    (dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+  const parallel::TriangulationBase<dim, spacedim> *p_tria =
+    (dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
       &dof_handler.get_triangulation()));
   MPI_Comm mpi_communicator =
     p_tria != nullptr ? p_tria->get_communicator() : MPI_COMM_SELF;
@@ -607,13 +607,14 @@ MGTransferBlockMatrixFree<dim, Number>::copy_to_mg(
   // dst == defect level block vector. At first run this vector is not
   // initialized. Do this below:
   {
-    const parallel::Triangulation<dim, spacedim> *tria =
-      (dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+    const parallel::TriangulationBase<dim, spacedim> *tria =
+      (dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
         &(mg_dof[0]->get_triangulation())));
     for (unsigned int i = 1; i < n_blocks; ++i)
-      AssertThrow((dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
-                     &(mg_dof[0]->get_triangulation())) == tria),
-                  ExcMessage("The DoFHandler use different Triangulations!"));
+      AssertThrow(
+        (dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
+           &(mg_dof[0]->get_triangulation())) == tria),
+        ExcMessage("The DoFHandler use different Triangulations!"));
 
     MGLevelObject<bool> do_reinit;
     do_reinit.resize(min_level, max_level);
index 8767265fec477dcdc0e4840f464175f0a48fb49a..d80de5d4ef9c1e5d0a2af2dd2b39993bc865f0f6 100644 (file)
@@ -2580,7 +2580,7 @@ namespace VectorTools
    * VectorTools::integrate_difference() and you normally want to supply the
    * same value for @p norm as you used in VectorTools::integrate_difference().
    *
-   * If the given Triangulation is a parallel::Triangulation, entries
+   * If the given Triangulation is a parallel::TriangulationBase, entries
    * in @p cellwise_error that do not correspond to locally owned cells are
    * assumed to be 0.0 and a parallel reduction using MPI is done to compute
    * the global error.
index fb16cd82e8cbe509f3572e9d4184b9ff0c1e2639..61a9b3588e8960216e3eecfbb639be5933cc06f0 100644 (file)
@@ -1462,7 +1462,7 @@ namespace VectorTools
                                         project_to_boundary_first);
       else
         {
-          Assert((dynamic_cast<const parallel::Triangulation<dim> *>(
+          Assert((dynamic_cast<const parallel::TriangulationBase<dim> *>(
                     &(dof.get_triangulation())) == nullptr),
                  ExcNotImplemented());
           do_project(mapping,
@@ -1823,9 +1823,10 @@ namespace VectorTools
       }
     else
       {
-        Assert((dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
-                  &(dof.get_triangulation())) == nullptr),
-               ExcNotImplemented());
+        Assert(
+          (dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
+             &(dof.get_triangulation())) == nullptr),
+          ExcNotImplemented());
         internal::do_project(mapping,
                              dof,
                              constraints,
@@ -1882,7 +1883,7 @@ namespace VectorTools
           const hp::QCollection<dim - 1> &q_boundary,
           const bool                      project_to_boundary_first)
   {
-    Assert((dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+    Assert((dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
               &(dof.get_triangulation())) == nullptr),
            ExcNotImplemented());
 
@@ -8440,8 +8441,9 @@ namespace VectorTools
 
     MPI_Comm comm = MPI_COMM_SELF;
 #ifdef DEAL_II_WITH_MPI
-    if (const parallel::Triangulation<dim, spacedim> *ptria =
-          dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(&tria))
+    if (const parallel::TriangulationBase<dim, spacedim> *ptria =
+          dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
+            &tria))
       comm = ptria->get_communicator();
 #endif
 
@@ -9071,8 +9073,8 @@ namespace VectorTools
 #ifdef DEAL_II_WITH_MPI
     // if this was a distributed DoFHandler, we need to do the reduction
     // over the entire domain
-    if (const parallel::Triangulation<dim, spacedim> *p_triangulation =
-          dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+    if (const parallel::TriangulationBase<dim, spacedim> *p_triangulation =
+          dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
             &dof.get_triangulation()))
       {
         // The type used to store the elements of the global vector may be a
index 70797886f6eec87ba0d6d7c824525080691288bd..cbd8891be26368ca7417cd6cca8ac77aa06abb0f 100644 (file)
@@ -28,7 +28,7 @@ namespace parallel
     const hp::DoFHandler<dim, spacedim> &dof_handler)
     : dof_handler(&dof_handler, typeid(*this).name())
   {
-    triangulation = (dynamic_cast<parallel::Triangulation<dim, spacedim> *>(
+    triangulation = (dynamic_cast<parallel::TriangulationBase<dim, spacedim> *>(
       const_cast<dealii::Triangulation<dim, spacedim> *>(
         &(this->dof_handler->get_triangulation()))));
 
@@ -49,7 +49,7 @@ namespace parallel
       Assert(
         triangulation != nullptr,
         ExcMessage(
-          "parallel::CellWeights requires a parallel::Triangulation object."));
+          "parallel::CellWeights requires a parallel::TriangulationBase object."));
   }
 
 
index 2cdb2040a952da4ddbd16c373e48247eea960bee..b408716ac76fe019c8834f3b8aad89fb42670ae5 100644 (file)
@@ -42,9 +42,9 @@ namespace parallel
                      smooth_grid,
       const bool     allow_artificial_cells,
       const Settings settings)
-      : dealii::parallel::Triangulation<dim, spacedim>(mpi_communicator,
-                                                       smooth_grid,
-                                                       false)
+      : dealii::parallel::TriangulationBase<dim, spacedim>(mpi_communicator,
+                                                           smooth_grid,
+                                                           false)
       , settings(settings)
       , allow_artificial_cells(allow_artificial_cells)
     {
@@ -392,7 +392,7 @@ namespace parallel
         ExcMessage(
           "Cannot use this function on parallel::distributed::Triangulation."));
 
-      dealii::parallel::Triangulation<dim, spacedim>::copy_triangulation(
+      dealii::parallel::TriangulationBase<dim, spacedim>::copy_triangulation(
         other_tria);
       partition();
       this->update_number_cache();
@@ -404,10 +404,10 @@ namespace parallel
     void
     Triangulation<dim, spacedim>::update_number_cache()
     {
-      parallel::Triangulation<dim, spacedim>::update_number_cache();
+      parallel::TriangulationBase<dim, spacedim>::update_number_cache();
 
       if (settings & construct_multigrid_hierarchy)
-        parallel::Triangulation<dim, spacedim>::fill_level_ghost_owners();
+        parallel::TriangulationBase<dim, spacedim>::fill_level_ghost_owners();
     }
   } // namespace shared
 } // namespace parallel
index f9f267bb8dce2e670b670df5c9299fd18f8d9b4c..590ec84593b245e16032c502346c60f672586f82 100644 (file)
@@ -2127,7 +2127,7 @@ namespace parallel
       : // Do not check for distorted cells.
         // For multigrid, we need limit_level_difference_at_vertices
         // to make sure the transfer operators only need to consider two levels.
-      dealii::parallel::Triangulation<dim, spacedim>(
+      dealii::parallel::TriangulationBase<dim, spacedim>(
         mpi_communicator,
         (settings_ & construct_multigrid_hierarchy) ?
           static_cast<
@@ -2880,10 +2880,10 @@ namespace parallel
     void
     Triangulation<dim, spacedim>::update_number_cache()
     {
-      parallel::Triangulation<dim, spacedim>::update_number_cache();
+      parallel::TriangulationBase<dim, spacedim>::update_number_cache();
 
       if (settings & construct_multigrid_hierarchy)
-        parallel::Triangulation<dim, spacedim>::fill_level_ghost_owners();
+        parallel::TriangulationBase<dim, spacedim>::fill_level_ghost_owners();
     }
 
 
@@ -4725,8 +4725,8 @@ namespace parallel
     Triangulation<dim, spacedim>::memory_consumption() const
     {
       std::size_t mem =
-        this->dealii::parallel::Triangulation<dim,
-                                              spacedim>::memory_consumption() +
+        this->dealii::parallel::TriangulationBase<dim, spacedim>::
+          memory_consumption() +
         MemoryConsumption::memory_consumption(triangulation_has_content) +
         MemoryConsumption::memory_consumption(connectivity) +
         MemoryConsumption::memory_consumption(parallel_forest) +
@@ -4767,8 +4767,8 @@ namespace parallel
     {
       try
         {
-          dealii::parallel::Triangulation<dim, spacedim>::copy_triangulation(
-            other_tria);
+          dealii::parallel::TriangulationBase<dim, spacedim>::
+            copy_triangulation(other_tria);
         }
       catch (
         const typename dealii::Triangulation<dim, spacedim>::DistortedCellList
@@ -4947,9 +4947,9 @@ namespace parallel
       const typename dealii::Triangulation<1, spacedim>::MeshSmoothing
         smooth_grid,
       const Settings /*settings*/)
-      : dealii::parallel::Triangulation<1, spacedim>(mpi_communicator,
-                                                     smooth_grid,
-                                                     false)
+      : dealii::parallel::TriangulationBase<1, spacedim>(mpi_communicator,
+                                                         smooth_grid,
+                                                         false)
     {
       Assert(false, ExcNotImplemented());
     }
index 587b32e2617707fc77be941ffe17ad6e6df809ec..1fd06d882056381b823c7a46f71d311303e764fc 100644 (file)
@@ -40,7 +40,7 @@ DEAL_II_NAMESPACE_OPEN
 namespace parallel
 {
   template <int dim, int spacedim>
-  Triangulation<dim, spacedim>::Triangulation(
+  TriangulationBase<dim, spacedim>::TriangulationBase(
     MPI_Comm mpi_communicator,
     const typename dealii::Triangulation<dim, spacedim>::MeshSmoothing
                smooth_grid,
@@ -54,7 +54,7 @@ namespace parallel
 #ifndef DEAL_II_WITH_MPI
     Assert(false,
            ExcMessage("You compiled deal.II without MPI support, for "
-                      "which parallel::Triangulation is not available."));
+                      "which parallel::TriangulationBase is not available."));
 #endif
     number_cache.n_locally_owned_active_cells.resize(n_subdomains);
   }
@@ -63,20 +63,20 @@ namespace parallel
 
   template <int dim, int spacedim>
   void
-  Triangulation<dim, spacedim>::copy_triangulation(
+  TriangulationBase<dim, spacedim>::copy_triangulation(
     const dealii::Triangulation<dim, spacedim> &other_tria)
   {
 #ifndef DEAL_II_WITH_MPI
     (void)other_tria;
     Assert(false,
            ExcMessage("You compiled deal.II without MPI support, for "
-                      "which parallel::Triangulation is not available."));
+                      "which parallel::TriangulationBase is not available."));
 #else
     dealii::Triangulation<dim, spacedim>::copy_triangulation(other_tria);
 
-    if (const dealii::parallel::Triangulation<dim, spacedim> *other_tria_x =
-          dynamic_cast<const dealii::parallel::Triangulation<dim, spacedim> *>(
-            &other_tria))
+    if (const dealii::parallel::TriangulationBase<dim, spacedim> *other_tria_x =
+          dynamic_cast<const dealii::parallel::TriangulationBase<dim, spacedim>
+                         *>(&other_tria))
       {
         mpi_communicator = other_tria_x->get_communicator();
 
@@ -92,7 +92,7 @@ namespace parallel
 
   template <int dim, int spacedim>
   std::size_t
-  Triangulation<dim, spacedim>::memory_consumption() const
+  TriangulationBase<dim, spacedim>::memory_consumption() const
   {
     std::size_t mem =
       this->dealii::Triangulation<dim, spacedim>::memory_consumption() +
@@ -107,7 +107,7 @@ namespace parallel
   }
 
   template <int dim, int spacedim>
-  Triangulation<dim, spacedim>::~Triangulation()
+  TriangulationBase<dim, spacedim>::~TriangulationBase()
   {
     // release unused vector memory because the vector layout is going to look
     // very different now
@@ -116,35 +116,35 @@ namespace parallel
   }
 
   template <int dim, int spacedim>
-  Triangulation<dim, spacedim>::NumberCache::NumberCache()
+  TriangulationBase<dim, spacedim>::NumberCache::NumberCache()
     : n_global_active_cells(0)
     , n_global_levels(0)
   {}
 
   template <int dim, int spacedim>
   unsigned int
-  Triangulation<dim, spacedim>::n_locally_owned_active_cells() const
+  TriangulationBase<dim, spacedim>::n_locally_owned_active_cells() const
   {
     return number_cache.n_locally_owned_active_cells[my_subdomain];
   }
 
   template <int dim, int spacedim>
   unsigned int
-  Triangulation<dim, spacedim>::n_global_levels() const
+  TriangulationBase<dim, spacedim>::n_global_levels() const
   {
     return number_cache.n_global_levels;
   }
 
   template <int dim, int spacedim>
   types::global_dof_index
-  Triangulation<dim, spacedim>::n_global_active_cells() const
+  TriangulationBase<dim, spacedim>::n_global_active_cells() const
   {
     return number_cache.n_global_active_cells;
   }
 
   template <int dim, int spacedim>
   const std::vector<unsigned int> &
-  Triangulation<dim, spacedim>::n_locally_owned_active_cells_per_processor()
+  TriangulationBase<dim, spacedim>::n_locally_owned_active_cells_per_processor()
     const
   {
     return number_cache.n_locally_owned_active_cells;
@@ -152,7 +152,7 @@ namespace parallel
 
   template <int dim, int spacedim>
   MPI_Comm
-  Triangulation<dim, spacedim>::get_communicator() const
+  TriangulationBase<dim, spacedim>::get_communicator() const
   {
     return mpi_communicator;
   }
@@ -160,7 +160,7 @@ namespace parallel
 #ifdef DEAL_II_WITH_MPI
   template <int dim, int spacedim>
   void
-  Triangulation<dim, spacedim>::update_number_cache()
+  TriangulationBase<dim, spacedim>::update_number_cache()
   {
     Assert(number_cache.n_locally_owned_active_cells.size() ==
              Utilities::MPI::n_mpi_processes(this->mpi_communicator),
@@ -233,7 +233,7 @@ namespace parallel
 
   template <int dim, int spacedim>
   void
-  Triangulation<dim, spacedim>::fill_level_ghost_owners()
+  TriangulationBase<dim, spacedim>::fill_level_ghost_owners()
   {
     number_cache.level_ghost_owners.clear();
 
@@ -316,14 +316,14 @@ namespace parallel
 
   template <int dim, int spacedim>
   void
-  Triangulation<dim, spacedim>::update_number_cache()
+  TriangulationBase<dim, spacedim>::update_number_cache()
   {
     Assert(false, ExcNotImplemented());
   }
 
   template <int dim, int spacedim>
   void
-  Triangulation<dim, spacedim>::fill_level_ghost_owners()
+  TriangulationBase<dim, spacedim>::fill_level_ghost_owners()
   {
     Assert(false, ExcNotImplemented());
   }
@@ -332,7 +332,7 @@ namespace parallel
 
   template <int dim, int spacedim>
   types::subdomain_id
-  Triangulation<dim, spacedim>::locally_owned_subdomain() const
+  TriangulationBase<dim, spacedim>::locally_owned_subdomain() const
   {
     return my_subdomain;
   }
@@ -341,7 +341,7 @@ namespace parallel
 
   template <int dim, int spacedim>
   const std::set<types::subdomain_id> &
-  Triangulation<dim, spacedim>::ghost_owners() const
+  TriangulationBase<dim, spacedim>::ghost_owners() const
   {
     return number_cache.ghost_owners;
   }
@@ -350,7 +350,7 @@ namespace parallel
 
   template <int dim, int spacedim>
   const std::set<types::subdomain_id> &
-  Triangulation<dim, spacedim>::level_ghost_owners() const
+  TriangulationBase<dim, spacedim>::level_ghost_owners() const
   {
     return number_cache.level_ghost_owners;
   }
@@ -359,7 +359,8 @@ namespace parallel
 
   template <int dim, int spacedim>
   std::map<unsigned int, std::set<dealii::types::subdomain_id>>
-  Triangulation<dim, spacedim>::compute_vertices_with_ghost_neighbors() const
+  TriangulationBase<dim, spacedim>::compute_vertices_with_ghost_neighbors()
+    const
   {
     // TODO: we are not treating periodic neighbors correctly here. If we do
     // we can remove the overriding implementation for p::d::Triangulation
index af043c2d717e13754c47ccabdf6b503b7d4ba9e4..3a6096f7ecbc166d2a2d7a04995271b9ff31ac37 100644 (file)
@@ -19,12 +19,14 @@ for (deal_II_dimension : DIMENSIONS)
   {
     namespace parallel
     \{
-      template class Triangulation<deal_II_dimension>;
+      template class TriangulationBase<deal_II_dimension>;
 #if deal_II_dimension < 3
-      template class Triangulation<deal_II_dimension, deal_II_dimension + 1>;
+      template class TriangulationBase<deal_II_dimension,
+                                       deal_II_dimension + 1>;
 #endif
 #if deal_II_dimension < 2
-      template class Triangulation<deal_II_dimension, deal_II_dimension + 2>;
+      template class TriangulationBase<deal_II_dimension,
+                                       deal_II_dimension + 2>;
 #endif
     \}
   }
index 08b99293b537016ee44d1a1841b98a4a9a0ae3c5..c5ab117f6a2ea315a668073c15f6ddadc3183093 100644 (file)
@@ -5757,8 +5757,8 @@ namespace internal
 
         constexpr int dim      = DoFHandlerType::dimension;
         constexpr int spacedim = DoFHandlerType::space_dimension;
-        const parallel::Triangulation<dim, spacedim> *tr =
-          (dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+        const parallel::TriangulationBase<dim, spacedim> *tr =
+          (dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
             &this->dof_handler->get_triangulation()));
         Assert(tr != nullptr, ExcInternalError());
 
index 9e22ce347fb4cb9bd5a2615d0e0d0074705e20c3..116488bd52dc68ad4e5b485bed624b768c5e2b2a 100644 (file)
@@ -867,8 +867,8 @@ namespace DoFRenumbering
     const unsigned int n_buckets = fe_collection.n_components();
     std::vector<types::global_dof_index> shifts(n_buckets);
 
-    if (const parallel::Triangulation<dim, spacedim> *tria =
-          (dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+    if (const parallel::TriangulationBase<dim, spacedim> *tria =
+          (dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
             &start->get_dof_handler().get_triangulation())))
       {
 #ifdef DEAL_II_WITH_MPI
@@ -1170,8 +1170,8 @@ namespace DoFRenumbering
     const unsigned int                   n_buckets = fe_collection.n_blocks();
     std::vector<types::global_dof_index> shifts(n_buckets);
 
-    if (const parallel::Triangulation<dim, spacedim> *tria =
-          (dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+    if (const parallel::TriangulationBase<dim, spacedim> *tria =
+          (dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
             &start->get_dof_handler().get_triangulation())))
       {
 #ifdef DEAL_II_WITH_MPI
@@ -1368,8 +1368,8 @@ namespace DoFRenumbering
     // DoFs for all previous processes
     types::global_dof_index my_starting_index = 0;
 
-    if (const parallel::Triangulation<dim, spacedim> *tria =
-          dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+    if (const parallel::TriangulationBase<dim, spacedim> *tria =
+          dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
             &dof_handler.get_triangulation()))
       {
 #ifdef DEAL_II_WITH_MPI
@@ -1586,12 +1586,11 @@ namespace DoFRenumbering
     const typename std::vector<typename DoFHandlerType::active_cell_iterator>
       &cells)
   {
-    if (const parallel::Triangulation<DoFHandlerType::dimension,
-                                      DoFHandlerType::space_dimension> *p =
-          dynamic_cast<
-            const parallel::Triangulation<DoFHandlerType::dimension,
-                                          DoFHandlerType::space_dimension> *>(
-            &dof.get_triangulation()))
+    if (const parallel::TriangulationBase<DoFHandlerType::dimension,
+                                          DoFHandlerType::space_dimension> *p =
+          dynamic_cast<const parallel::TriangulationBase<
+            DoFHandlerType::dimension,
+            DoFHandlerType::space_dimension> *>(&dof.get_triangulation()))
       {
         AssertDimension(cells.size(), p->n_locally_owned_active_cells());
       }
@@ -1753,11 +1752,12 @@ namespace DoFRenumbering
     const Tensor<1, DoFHandlerType::space_dimension> &direction,
     const bool                                        dof_wise_renumbering)
   {
-    Assert((dynamic_cast<
-              const parallel::Triangulation<DoFHandlerType::dimension,
-                                            DoFHandlerType::space_dimension> *>(
-              &dof.get_triangulation()) == nullptr),
-           ExcNotImplemented());
+    Assert(
+      (dynamic_cast<
+         const parallel::TriangulationBase<DoFHandlerType::dimension,
+                                           DoFHandlerType::space_dimension> *>(
+         &dof.get_triangulation()) == nullptr),
+      ExcNotImplemented());
 
     if (dof_wise_renumbering == false)
       {
@@ -2198,8 +2198,8 @@ namespace DoFRenumbering
   {
     Assert(
       (!dynamic_cast<
-        const parallel::Triangulation<DoFHandlerType::dimension,
-                                      DoFHandlerType::space_dimension> *>(
+        const parallel::TriangulationBase<DoFHandlerType::dimension,
+                                          DoFHandlerType::space_dimension> *>(
         &dof_handler.get_triangulation())),
       ExcMessage(
         "Parallel triangulations are already enumerated according to their MPI process id."));
index 0f241f3ff42ba8050f39142aa85a91ed011ae11e..a492783d7725a88d460f69b5669f24085fd2562e 100644 (file)
@@ -1307,9 +1307,9 @@ namespace DoFTools
     // collect information for each subdomain index anyway, not just for the
     // used one.)
     const unsigned int n_subdomains =
-      (dynamic_cast<
-           const parallel::Triangulation<DoFHandlerType::dimension,
-                                         DoFHandlerType::space_dimension> *>(
+      (dynamic_cast<const parallel::TriangulationBase<
+             DoFHandlerType::dimension,
+             DoFHandlerType::space_dimension> *>(
          &dof_handler.get_triangulation()) == nullptr ?
          [&dof_handler]() {
            unsigned int max_subdomain_id = 0;
@@ -1319,9 +1319,9 @@ namespace DoFTools
            return max_subdomain_id + 1;
          }() :
          Utilities::MPI::n_mpi_processes(
-           dynamic_cast<
-             const parallel::Triangulation<DoFHandlerType::dimension,
-                                           DoFHandlerType::space_dimension> *>(
+           dynamic_cast<const parallel::TriangulationBase<
+             DoFHandlerType::dimension,
+             DoFHandlerType::space_dimension> *>(
              &dof_handler.get_triangulation())
              ->get_communicator()));
     Assert(n_subdomains > *std::max_element(subdomain_association.begin(),
@@ -1870,8 +1870,8 @@ namespace DoFTools
     const unsigned int dim      = DoFHandlerType::dimension;
     const unsigned int spacedim = DoFHandlerType::space_dimension;
 
-    if (const parallel::Triangulation<dim, spacedim> *tria =
-          (dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+    if (const parallel::TriangulationBase<dim, spacedim> *tria =
+          (dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
             &dof_handler.get_triangulation())))
       {
         std::vector<types::global_dof_index> local_dof_count =
@@ -1955,9 +1955,9 @@ namespace DoFTools
 #ifdef DEAL_II_WITH_MPI
         // if we are working on a parallel mesh, we now need to collect
         // this information from all processors
-        if (const parallel::Triangulation<DoFHandlerType::dimension,
-                                          DoFHandlerType::space_dimension>
-              *tria = (dynamic_cast<const parallel::Triangulation<
+        if (const parallel::TriangulationBase<DoFHandlerType::dimension,
+                                              DoFHandlerType::space_dimension>
+              *tria = (dynamic_cast<const parallel::TriangulationBase<
                          DoFHandlerType::dimension,
                          DoFHandlerType::space_dimension> *>(
                 &dof_handler.get_triangulation())))
index 3a9e3f65b4f85bef2d1fec1e69c4c2a454f39ac3..c4a250a4288ec2977b3b3e3be620e1aeee7a95df 100644 (file)
@@ -2788,9 +2788,10 @@ namespace DoFTools
             MPI_Comm communicator = MPI_COMM_SELF;
             try
               {
-                const typename dealii::parallel::Triangulation<dim, spacedim>
+                const typename dealii::parallel::TriangulationBase<dim,
+                                                                   spacedim>
                   &tria = dynamic_cast<const typename dealii::parallel::
-                                         Triangulation<dim, spacedim> &>(
+                                         TriangulationBase<dim, spacedim> &>(
                     coarse_to_fine_grid_map.get_destination_grid()
                       .get_triangulation());
                 communicator          = tria.get_communicator();
index 2eae88e68bbf8b2df78e07b29b446f58ad7c16b4..f813fce4772a3694bbb5169b95fb76dbcceb9558 100644 (file)
@@ -232,9 +232,9 @@ namespace DoFTools
     // and dofs on a cell owned by a different processor.
     constexpr int dim      = DoFHandlerType::dimension;
     constexpr int spacedim = DoFHandlerType::space_dimension;
-    if (dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+    if (dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
           &dof_row.get_triangulation()) != nullptr ||
-        dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+        dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
           &dof_col.get_triangulation()) != nullptr)
       {
         Assert(&dof_row.get_triangulation() == &dof_col.get_triangulation(),
index ec08f50cc9c604a8a1f0a0193cbd008792bb9f19..696acc4e97002b428288bf32fadd1fbd7d40cfa8 100644 (file)
@@ -3283,8 +3283,8 @@ GridOut::write_mesh_per_processor_as_vtu(
   // if not, just create a .vtu file with no reference
   // to the processor number
   std::string new_file = filename_without_extension + ".vtu";
-  if (const parallel::Triangulation<dim, spacedim> *tr =
-        dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(&tria))
+  if (const parallel::TriangulationBase<dim, spacedim> *tr =
+        dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(&tria))
     {
       new_file = filename_without_extension + ".proc" +
                  Utilities::int_to_string(tr->locally_owned_subdomain(), 4) +
index d0890f014d235072e6cdbd1304aae2475ab066c9..9b2f8197bdb3a903ba6fbe9c8e34cd8425a38eaa 100644 (file)
@@ -173,8 +173,8 @@ namespace GridTools
     double global_volume = 0;
 
 #ifdef DEAL_II_WITH_MPI
-    if (const parallel::Triangulation<dim, spacedim> *p_tria =
-          dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+    if (const parallel::TriangulationBase<dim, spacedim> *p_tria =
+          dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
             &triangulation))
       global_volume =
         Utilities::MPI::sum(local_volume, p_tria->get_communicator());
@@ -3129,8 +3129,8 @@ namespace GridTools
     double global_min_diameter = 0;
 
 #ifdef DEAL_II_WITH_MPI
-    if (const parallel::Triangulation<dim, spacedim> *p_tria =
-          dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+    if (const parallel::TriangulationBase<dim, spacedim> *p_tria =
+          dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
             &triangulation))
       global_min_diameter =
         Utilities::MPI::min(min_diameter, p_tria->get_communicator());
@@ -3156,8 +3156,8 @@ namespace GridTools
     double global_max_diameter = 0;
 
 #ifdef DEAL_II_WITH_MPI
-    if (const parallel::Triangulation<dim, spacedim> *p_tria =
-          dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+    if (const parallel::TriangulationBase<dim, spacedim> *p_tria =
+          dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
             &triangulation))
       global_max_diameter =
         Utilities::MPI::max(max_diameter, p_tria->get_communicator());
@@ -5087,7 +5087,7 @@ namespace GridTools
 #else
     // Recovering the mpi communicator used to create the triangulation
     const auto &tria_mpi =
-      dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+      dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
         &cache.get_triangulation());
     // If the dynamic cast failed we can't recover the mpi communicator:
     // throwing an assertion error
index 048489b1bcc56ab153e43a4d4a80e34532608634..938ca9d725226a017e50a746584e1a8867dd2f5e 100644 (file)
@@ -183,7 +183,7 @@ namespace GridTools
 
         std::vector<BoundingBox<spacedim>> bbox_v(1, bbox);
         if (const auto tria_mpi =
-              dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+              dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
                 &(*tria)))
           {
             covering_rtree = GridTools::build_global_description_tree(
index 8c04804bbad5be0c375d8ab179d2474351ca9223..c4b84a7b47c89773447996d351414f97cb6bcd81 100644 (file)
@@ -1069,10 +1069,11 @@ namespace internal
           else
             {
               // a sequential triangulation. there is nothing we need to do here
-              Assert((dynamic_cast<
-                        const dealii::parallel::Triangulation<dim, spacedim> *>(
-                        &dof_handler.get_triangulation()) == nullptr),
-                     ExcInternalError());
+              Assert(
+                (dynamic_cast<
+                   const dealii::parallel::TriangulationBase<dim, spacedim> *>(
+                   &dof_handler.get_triangulation()) == nullptr),
+                ExcInternalError());
             }
         }
 
index bd2436d96ca0640ae71920367752c1f73158bb21..ff30ad67cbbd419ec8ca238f43915d010e69ddb1 100644 (file)
@@ -133,8 +133,8 @@ namespace hp
               }
           }
 
-      if (const parallel::Triangulation<dim, spacedim> *parallel_tria =
-            dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+      if (const parallel::TriangulationBase<dim, spacedim> *parallel_tria =
+            dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
               &dof_handler.get_triangulation()))
         {
           max_smoothness_refine =
index d0a36c9f88f9d3eaccc732fe3fd8e91268e59a60..5ac77d336dc8102513feb2bd18b43c41614af408 100644 (file)
@@ -83,8 +83,8 @@ MGLevelGlobalTransfer<VectorType>::fill_and_communicate_copy_indices(
 
   // now do a global reduction over all processors to see what operation
   // they can agree upon
-  if (const parallel::Triangulation<dim, spacedim> *ptria =
-        dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+  if (const parallel::TriangulationBase<dim, spacedim> *ptria =
+        dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
           &mg_dof.get_triangulation()))
     perform_plain_copy = (Utilities::MPI::min(my_perform_plain_copy ? 1 : 0,
                                               ptria->get_communicator()) == 1);
@@ -295,8 +295,8 @@ void
 MGLevelGlobalTransfer<LinearAlgebra::distributed::Vector<Number>>::
   fill_and_communicate_copy_indices(const DoFHandler<dim, spacedim> &mg_dof)
 {
-  const parallel::Triangulation<dim, spacedim> *ptria =
-    dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+  const parallel::TriangulationBase<dim, spacedim> *ptria =
+    dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
       &mg_dof.get_triangulation());
   const MPI_Comm mpi_communicator =
     ptria != nullptr ? ptria->get_communicator() : MPI_COMM_SELF;
index 4d3c8c04f2571142a8bdb9f97147c3a99fe534e9..f45b2f1c6800e53211dc1cc16c553bb63184202f 100644 (file)
@@ -1653,8 +1653,9 @@ namespace MGTools
     unsigned int global_min = min_level;
     // If necessary, communicate to find minimum
     // level for an active cell over all subdomains
-    if (const parallel::Triangulation<dim, spacedim> *tr =
-          dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(&tria))
+    if (const parallel::TriangulationBase<dim, spacedim> *tr =
+          dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
+            &tria))
       global_min = Utilities::MPI::min(min_level, tr->get_communicator());
 
     AssertIndexRange(global_min, tria.n_global_levels());
@@ -1673,8 +1674,9 @@ namespace MGTools
     // It is only necessary to calculate the imbalance
     // on a distributed mesh. The imbalance is always
     // 1.0 for the serial case.
-    if (const parallel::Triangulation<dim, spacedim> *tr =
-          dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(&tria))
+    if (const parallel::TriangulationBase<dim, spacedim> *tr =
+          dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
+            &tria))
       {
         const unsigned int n_proc =
           Utilities::MPI::n_mpi_processes(tr->get_communicator());
index 1edb807932c6984642e53e4bfbda90a0fe7f90c9..2bab12fc32a1604e93a64e667ed32fe1880214df 100644 (file)
@@ -169,8 +169,8 @@ namespace internal
             }
         }
 
-      const dealii::parallel::Triangulation<dim, spacedim> *tria =
-        (dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+      const dealii::parallel::TriangulationBase<dim, spacedim> *tria =
+        (dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
           &mg_dof.get_triangulation()));
       AssertThrow(
         send_data_temp.size() == 0 || tria != nullptr,
@@ -856,8 +856,9 @@ namespace internal
                 }
 
           // step 2.7: Initialize the ghosted vector
-          const parallel::Triangulation<dim, dim> *ptria =
-            (dynamic_cast<const parallel::Triangulation<dim, dim> *>(&tria));
+          const parallel::TriangulationBase<dim, dim> *ptria =
+            (dynamic_cast<const parallel::TriangulationBase<dim, dim> *>(
+              &tria));
           const MPI_Comm communicator =
             ptria != nullptr ? ptria->get_communicator() : MPI_COMM_SELF;
 
index 3649998289e2ed9a2ab0838961d7f2ea89288969..a65380efffbddaf13adcc63067bd7217f4449012 100644 (file)
@@ -273,8 +273,8 @@ MGTransferPrebuilt<VectorType>::build_matrices(
           // be manually distributed.
 
           // Retrieve communicator from triangulation if it is parallel
-          const parallel::Triangulation<dim, spacedim> *dist_tria =
-            dynamic_cast<const parallel::Triangulation<dim, spacedim> *>(
+          const parallel::TriangulationBase<dim, spacedim> *dist_tria =
+            dynamic_cast<const parallel::TriangulationBase<dim, spacedim> *>(
               &(mg_dof.get_triangulation()));
 
           MPI_Comm communicator = dist_tria != nullptr ?
index 5bc44873f0bcfd3b5fba8c3d4576f3a9c88c1f25..467528a81a46edbc67ddea7a45f4b8bbaaf1e6a9 100644 (file)
@@ -184,7 +184,7 @@ namespace NonMatching
            ExcNotImplemented());
 
     const bool tria_is_parallel =
-      (dynamic_cast<const parallel::Triangulation<dim1, spacedim> *>(
+      (dynamic_cast<const parallel::TriangulationBase<dim1, spacedim> *>(
          &space_dh.get_triangulation()) != nullptr);
     const auto &space_fe    = space_dh.get_fe();
     const auto &immersed_fe = immersed_dh.get_fe();
@@ -367,7 +367,7 @@ namespace NonMatching
            ExcNotImplemented());
 
     const bool tria_is_parallel =
-      (dynamic_cast<const parallel::Triangulation<dim1, spacedim> *>(
+      (dynamic_cast<const parallel::TriangulationBase<dim1, spacedim> *>(
          &space_dh.get_triangulation()) != nullptr);
 
     const auto &space_fe    = space_dh.get_fe();

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.