]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Deprecate (hp::)?DoFHandler::get_tria; introduce get_triangulation.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 10 Dec 2015 15:51:13 +0000 (09:51 -0600)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 10 Dec 2015 15:51:13 +0000 (09:51 -0600)
include/deal.II/dofs/dof_handler.h
include/deal.II/grid/tria.h
include/deal.II/hp/dof_handler.h
source/grid/grid_generator.cc
source/grid/grid_tools.cc
source/grid/intergrid_map.cc
source/grid/tria.cc

index 2a3beb560326b2426d41e32e12e1b2ff30977989..7e9466a66c4df8aa1394aeec2a01ae8e44057d2b 100644 (file)
@@ -796,10 +796,17 @@ public:
    */
   const FiniteElement<dim,spacedim> &get_fe () const;
 
+  /**
+   * Return a constant reference to the triangulation underlying this object.
+   *
+   * @deprecated Use get_triangulation() instead.
+   */
+  const Triangulation<dim,spacedim> &get_tria () const DEAL_II_DEPRECATED;
+
   /**
    * Return a constant reference to the triangulation underlying this object.
    */
-  const Triangulation<dim,spacedim> &get_tria () const;
+  const Triangulation<dim,spacedim> &get_triangulation () const;
 
   /**
    * Determine an estimate for the memory consumption (in bytes) of this
@@ -1153,7 +1160,7 @@ template <int dim, int spacedim>
 const IndexSet &
 DoFHandler<dim, spacedim>::locally_owned_mg_dofs(const unsigned int level) const
 {
-  Assert(level < this->get_tria().n_global_levels(), ExcMessage("invalid level in locally_owned_mg_dofs"));
+  Assert(level < this->get_triangulation().n_global_levels(), ExcMessage("invalid level in locally_owned_mg_dofs"));
   return mg_number_cache[level].locally_owned_dofs;
 }
 
@@ -1176,7 +1183,7 @@ template <int dim, int spacedim>
 const std::vector<IndexSet> &
 DoFHandler<dim, spacedim>::locally_owned_mg_dofs_per_processor (const unsigned int level) const
 {
-  Assert(level < this->get_tria().n_global_levels(), ExcMessage("invalid level in locally_owned_mg_dofs_per_processor"));
+  Assert(level < this->get_triangulation().n_global_levels(), ExcMessage("invalid level in locally_owned_mg_dofs_per_processor"));
   return mg_number_cache[level].locally_owned_dofs_per_processor;
 }
 
@@ -1191,6 +1198,7 @@ DoFHandler<dim,spacedim>::get_fe () const
 }
 
 
+
 template <int dim, int spacedim>
 inline
 const Triangulation<dim,spacedim> &
@@ -1201,6 +1209,18 @@ DoFHandler<dim,spacedim>::get_tria () const
 }
 
 
+
+template <int dim, int spacedim>
+inline
+const Triangulation<dim,spacedim> &
+DoFHandler<dim,spacedim>::get_triangulation () const
+{
+  Assert(tria != 0, ExcNotInitialized());
+  return *tria;
+}
+
+
+
 template <int dim, int spacedim>
 inline
 const BlockInfo &
index 47b209ff87029f4d99fb5a6c6d7deb0f5120c06c..63ad4f5ff8f9b564649f61cab8918ad7bb05f955 100644 (file)
@@ -2821,14 +2821,14 @@ public:
    * may not only be a triangulation, but also a DoFHandler, for example).
    */
   Triangulation<dim,spacedim> &
-  get_tria ();
+  get_triangulation ();
 
   /**
    * Return a reference to the current object. This is the const-version
    * of the previous function.
    */
   const Triangulation<dim,spacedim> &
-  get_tria () const;
+  get_triangulation () const;
 
 
   /*
index c6ccf3ae6521d9b7421dd08ae5b5ab925cfc4a18..16abd9f14ba6c53abd3f592d2804691e15934aa9 100644 (file)
@@ -592,10 +592,16 @@ namespace hp
     const hp::FECollection<dim,spacedim> &get_fe () const;
 
     /**
-     * Return a constant reference to the triangulation underlying this
-     * object.
+     * Return a constant reference to the triangulation underlying this object.
+     *
+     * @deprecated Use get_triangulation() instead.
+     */
+    const Triangulation<dim,spacedim> &get_tria () const DEAL_II_DEPRECATED;
+
+    /**
+     * Return a constant reference to the triangulation underlying this object.
      */
-    const Triangulation<dim,spacedim> &get_tria () const;
+    const Triangulation<dim,spacedim> &get_triangulation () const;
 
     /**
      * Determine an estimate for the memory consumption (in bytes) of this
@@ -1010,6 +1016,7 @@ namespace hp
   }
 
 
+
   template<int dim, int spacedim>
   inline
   const Triangulation<dim,spacedim> &
@@ -1018,6 +1025,18 @@ namespace hp
     return *tria;
   }
 
+
+
+  template<int dim, int spacedim>
+  inline
+  const Triangulation<dim,spacedim> &
+  DoFHandler<dim,spacedim>::get_triangulation () const
+  {
+    return *tria;
+  }
+
+
+
   template<int dim, int spacedim>
   inline
   DoFHandler<dim, spacedim>::MGVertexDoFs::MGVertexDoFs()
index 3cdf44852aa33618b267207cac724be7719e2e7f..8eb975d01eda339a79816b2783ba4b0e32b68b57 100644 (file)
@@ -4157,7 +4157,7 @@ namespace GridGenerator
     mapping;  // temporary map for level==0
 
 
-    std::vector< bool > touched (volume_mesh.get_tria().n_vertices(), false);
+    std::vector< bool > touched (volume_mesh.get_triangulation().n_vertices(), false);
     std::vector< CellData< boundary_dim > > cells;
     SubCellData                             subcell_data;
     std::vector< Point<spacedim> >          vertices;
@@ -4267,7 +4267,7 @@ namespace GridGenerator
 
     // create level 0 surface triangulation
     Assert (cells.size() > 0, ExcMessage ("No boundary faces selected"));
-    const_cast<Triangulation<dim-1,spacedim>&>(surface_mesh.get_tria())
+    const_cast<Triangulation<dim-1,spacedim>&>(surface_mesh.get_triangulation())
     .create_triangulation (vertices, cells, subcell_data);
 
     // Make the actual mapping
@@ -4290,7 +4290,7 @@ namespace GridGenerator
 
         if (changed)
           {
-            const_cast<Triangulation<dim-1,spacedim>&>(surface_mesh.get_tria())
+            const_cast<Triangulation<dim-1,spacedim>&>(surface_mesh.get_triangulation())
             .execute_coarsening_and_refinement();
 
             for (typename Container<dim-1,spacedim>::cell_iterator
index 05f77090b292ea80bbc6b506af17c47cf347f214..8f569d8588e0c5ac846862a1e582968333bfe2af 100644 (file)
@@ -964,7 +964,7 @@ namespace GridTools
     // triangulation from the
     // container and determine vertices
     // and used vertices
-    const Triangulation<dim, spacedim> &tria = container.get_tria();
+    const Triangulation<dim, spacedim> &tria = container.get_triangulation();
 
     const std::vector< Point<spacedim> > &vertices = tria.get_vertices();
     const std::vector< bool       > &used     = tria.get_used_vertices();
@@ -1010,9 +1010,9 @@ namespace GridTools
     // make sure that the given vertex is
     // an active vertex of the underlying
     // triangulation
-    Assert(vertex < container.get_tria().n_vertices(),
-           ExcIndexRange(0,container.get_tria().n_vertices(),vertex));
-    Assert(container.get_tria().get_used_vertices()[vertex],
+    Assert(vertex < container.get_triangulation().n_vertices(),
+           ExcIndexRange(0,container.get_triangulation().n_vertices(),vertex));
+    Assert(container.get_triangulation().get_used_vertices()[vertex],
            ExcVertexNotUsed(vertex));
 
     // use a set instead of a vector
@@ -1252,7 +1252,7 @@ next_cell:
     // the cell and have not searched
     // every cell in the triangulation,
     // we keep on looking.
-    const unsigned int n_active_cells = container.get_tria().n_active_cells();
+    const unsigned int n_active_cells = container.get_triangulation().n_active_cells();
     bool found = false;
     unsigned int cells_searched = 0;
     while (!found && cells_searched < n_active_cells)
@@ -1380,7 +1380,7 @@ next_cell:
         // the cell and have not searched
         // every cell in the triangulation,
         // we keep on looking.
-        const unsigned int n_cells = container.get_tria().n_cells();
+        const unsigned int n_cells = container.get_triangulation().n_cells();
         bool found = false;
         unsigned int cells_searched = 0;
         while (!found && cells_searched < n_cells)
@@ -1489,7 +1489,7 @@ next_cell:
                                   const std_cxx11::function<bool (const typename Container::active_cell_iterator &)> &predicate)
   {
     std::vector<typename Container::active_cell_iterator> active_halo_layer;
-    std::vector<bool> locally_active_vertices_on_subdomain (container.get_tria().n_vertices(),
+    std::vector<bool> locally_active_vertices_on_subdomain (container.get_triangulation().n_vertices(),
                                                             false);
 
     // Find the cells for which the predicate is true
@@ -2225,8 +2225,8 @@ next_cell:
   have_same_coarse_mesh (const Container &mesh_1,
                          const Container &mesh_2)
   {
-    return have_same_coarse_mesh (mesh_1.get_tria(),
-                                  mesh_2.get_tria());
+    return have_same_coarse_mesh (mesh_1.get_triangulation(),
+                                  mesh_2.get_triangulation());
   }
 
 
index 6441f8302f266cafc9db22d033408c71daed724a..e6b2a81dc337680ad0715a5907456c344209293d 100644 (file)
@@ -52,7 +52,7 @@ void InterGridMap<GridClass>::make_mapping (const GridClass &source_grid,
 
   // then set up the containers from
   // scratch and fill them with end-iterators
-  const unsigned int n_levels = source_grid.get_tria().n_levels();
+  const unsigned int n_levels = source_grid.get_triangulation().n_levels();
   mapping.resize (n_levels);
   for (unsigned int level=0; level<n_levels; ++level)
     {
index 01a5d7a8221612ca53c7b0692ccbb50aae4f1f21..540433f3a606d9631091026285d9d60c2740b7f6 100644 (file)
@@ -11575,7 +11575,7 @@ Triangulation<dim,spacedim>::locally_owned_subdomain () const
 
 template <int dim, int spacedim>
 Triangulation<dim,spacedim> &
-Triangulation<dim,spacedim>::get_tria ()
+Triangulation<dim,spacedim>::get_triangulation ()
 {
   return *this;
 }
@@ -11584,7 +11584,7 @@ Triangulation<dim,spacedim>::get_tria ()
 
 template <int dim, int spacedim>
 const Triangulation<dim,spacedim> &
-Triangulation<dim,spacedim>::get_tria () const
+Triangulation<dim,spacedim>::get_triangulation () const
 {
   return *this;
 }

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.