]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove deprecated functions (hp::)DoFHandler::get_tria().
authorWolfgang Bangerth <bangerth@colostate.edu>
Tue, 25 Apr 2017 22:35:32 +0000 (16:35 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Tue, 25 Apr 2017 22:35:32 +0000 (16:35 -0600)
include/deal.II/dofs/dof_handler.h
include/deal.II/fe/fe_tools_extrapolate.templates.h
include/deal.II/hp/dof_handler.h
source/hp/dof_handler.cc
source/multigrid/mg_level_global_transfer.cc
source/numerics/solution_transfer.cc

index c9b88b814865930d2f49db5a98a517901e0712f1..c4fe7509d2c9888f755e3273c622a469e72005ee 100644 (file)
@@ -810,13 +810,6 @@ 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.
    */
@@ -1220,17 +1213,6 @@ DoFHandler<dim,spacedim>::get_fe () const
 
 
 
-template <int dim, int spacedim>
-inline
-const Triangulation<dim,spacedim> &
-DoFHandler<dim,spacedim>::get_tria () const
-{
-  Assert(tria != nullptr, ExcNotInitialized());
-  return *tria;
-}
-
-
-
 template <int dim, int spacedim>
 inline
 const Triangulation<dim,spacedim> &
index 23c79145755ffc2e68b55d48ce894c5050d2cd0c..cea9bffec08427d3ac51d75ef9e112296344cd67 100644 (file)
@@ -728,7 +728,7 @@ namespace FETools
     {
       const parallel::distributed::Triangulation< dim, spacedim > *tr
         = (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>
-           (&dof2.get_tria()));
+           (&dof2.get_triangulation()));
 
       Assert (tr != nullptr, ExcInternalError());
 
@@ -919,7 +919,7 @@ namespace FETools
     {
       const parallel::distributed::Triangulation< dim, spacedim > *tr
         = (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>
-           (&dof2.get_tria()));
+           (&dof2.get_triangulation()));
 
       Assert (tr != nullptr, ExcInternalError());
 
@@ -1296,7 +1296,7 @@ namespace FETools
     {
       const parallel::distributed::Triangulation< dim, spacedim > *tr
         = (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>
-           (&dof2.get_tria()));
+           (&dof2.get_triangulation()));
 
       Assert (tr != nullptr,
               ExcMessage ("Extrapolate in parallel only works for parallel distributed triangulations!"));
@@ -1431,7 +1431,7 @@ namespace FETools
                               PETScWrappers::MPI::Vector &vector)
       {
         const parallel::distributed::Triangulation<dim,spacedim> *parallel_tria =
-          dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_tria());
+          dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_triangulation());
         Assert (parallel_tria != nullptr, ExcNotImplemented());
 
         const IndexSet locally_owned_dofs = dh.locally_owned_dofs();
@@ -1445,7 +1445,7 @@ namespace FETools
                               TrilinosWrappers::MPI::Vector &vector)
       {
         const parallel::distributed::Triangulation<dim,spacedim> *parallel_tria =
-          dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_tria());
+          dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_triangulation());
         Assert (parallel_tria != nullptr, ExcNotImplemented());
 
         const IndexSet locally_owned_dofs = dh.locally_owned_dofs();
@@ -1460,7 +1460,7 @@ namespace FETools
                               LinearAlgebra::EpetraWrappers::Vector &vector)
       {
         const parallel::distributed::Triangulation<dim,spacedim> *parallel_tria =
-          dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_tria());
+          dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_triangulation());
         Assert (parallel_tria !=0, ExcNotImplemented());
 
         const IndexSet locally_owned_dofs = dh.locally_owned_dofs();
@@ -1474,7 +1474,7 @@ namespace FETools
                               LinearAlgebra::distributed::Vector<Number> &vector)
       {
         const parallel::distributed::Triangulation<dim,spacedim> *parallel_tria =
-          dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_tria());
+          dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_triangulation());
         Assert (parallel_tria != nullptr, ExcNotImplemented());
 
         const IndexSet locally_owned_dofs = dh.locally_owned_dofs();
@@ -1496,7 +1496,7 @@ namespace FETools
                           PETScWrappers::MPI::Vector &vector)
       {
         const parallel::distributed::Triangulation<dim,spacedim> *parallel_tria =
-          dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_tria());
+          dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_triangulation());
         Assert(parallel_tria != nullptr, ExcNotImplemented());
         const IndexSet  locally_owned_dofs = dh.locally_owned_dofs();
         IndexSet  locally_relevant_dofs;
@@ -1512,7 +1512,7 @@ namespace FETools
                           TrilinosWrappers::MPI::Vector &vector)
       {
         const parallel::distributed::Triangulation<dim,spacedim> *parallel_tria =
-          dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_tria());
+          dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_triangulation());
         Assert (parallel_tria != nullptr, ExcNotImplemented());
         const IndexSet  locally_owned_dofs = dh.locally_owned_dofs();
         IndexSet  locally_relevant_dofs;
@@ -1527,7 +1527,7 @@ namespace FETools
                           LinearAlgebra::distributed::Vector<Number> &vector)
       {
         const parallel::distributed::Triangulation<dim,spacedim> *parallel_tria =
-          dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_tria());
+          dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dh.get_triangulation());
         Assert (parallel_tria != nullptr, ExcNotImplemented());
         const IndexSet  locally_owned_dofs = dh.locally_owned_dofs();
         IndexSet  locally_relevant_dofs;
@@ -1622,7 +1622,7 @@ namespace FETools
 
     internal::BlockType<OutVector> u3;
     internal::reinit_distributed(dof2, u3);
-    if (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dof2.get_tria()) != nullptr)
+    if (dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim>*>(&dof2.get_triangulation()) != nullptr)
       {
         interpolate(dof1, u1, dof2, constraints, u3);
 
index 2be4054db81c86aeefa388d924090b49b6cce392..cd1c5789e690f6685c4d0a47d4bc58d5cdc73f50 100644 (file)
@@ -603,14 +603,6 @@ namespace hp
      */
     const hp::FECollection<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.
@@ -1050,16 +1042,6 @@ namespace hp
 
 
 
-  template<int dim, int spacedim>
-  inline
-  const Triangulation<dim,spacedim> &
-  DoFHandler<dim,spacedim>::get_tria () const
-  {
-    return *tria;
-  }
-
-
-
   template<int dim, int spacedim>
   inline
   const Triangulation<dim,spacedim> &
index 7bdb99eb373d38c01f2a5341f17384d58ee42105..c2670a1a5791048b3d2e5532b4d514303c956881 100644 (file)
@@ -2106,7 +2106,7 @@ namespace hp
     // loop over all vertices and
     // see which one we need to
     // work on
-    for (unsigned int vertex_index=0; vertex_index<get_tria().n_vertices();
+    for (unsigned int vertex_index=0; vertex_index<get_triangulation().n_vertices();
          ++vertex_index)
       {
         const unsigned int n_active_fe_indices
@@ -2533,8 +2533,8 @@ namespace hp
   template <int dim, int spacedim>
   void DoFHandler<dim,spacedim>::set_active_fe_indices (const std::vector<unsigned int> &active_fe_indices)
   {
-    Assert(active_fe_indices.size()==get_tria().n_active_cells(),
-           ExcDimensionMismatch(active_fe_indices.size(), get_tria().n_active_cells()));
+    Assert(active_fe_indices.size()==get_triangulation().n_active_cells(),
+           ExcDimensionMismatch(active_fe_indices.size(), get_triangulation().n_active_cells()));
 
     create_active_fe_table ();
     // we could set the values directly, since
@@ -2555,7 +2555,7 @@ namespace hp
   template <int dim, int spacedim>
   void DoFHandler<dim,spacedim>::get_active_fe_indices (std::vector<unsigned int> &active_fe_indices) const
   {
-    active_fe_indices.resize(get_tria().n_active_cells());
+    active_fe_indices.resize(get_triangulation().n_active_cells());
 
     // we could try to extract the values directly, since
     // they are stored as protected data of
@@ -2800,7 +2800,7 @@ namespace hp
   {
     Assert (new_numbers.size() == n_dofs(), ExcRenumberingIncomplete());
 
-    for (unsigned int vertex_index=0; vertex_index<get_tria().n_vertices();
+    for (unsigned int vertex_index=0; vertex_index<get_triangulation().n_vertices();
          ++vertex_index)
       {
         const unsigned int n_active_fe_indices
index 13b4ef7cdceb66b3b25c64aae589cd3f89276a28..1ef738e1935fa48fddc1ac4cd6cff79fed19e3a7 100644 (file)
@@ -76,7 +76,7 @@ MGLevelGlobalTransfer<VectorType>::fill_and_communicate_copy_indices
     }
   const parallel::Triangulation<dim, spacedim> *ptria =
     dynamic_cast<const parallel::Triangulation<dim, spacedim> *>
-    (&mg_dof.get_tria());
+    (&mg_dof.get_triangulation());
   const MPI_Comm mpi_communicator = ptria != nullptr ? ptria->get_communicator() :
                                     MPI_COMM_SELF;
   perform_plain_copy =
@@ -173,7 +173,7 @@ MGLevelGlobalTransfer<LinearAlgebra::distributed::Vector<Number> >::fill_and_com
   // precisely the indices that we need)
   const parallel::Triangulation<dim, spacedim> *ptria =
     dynamic_cast<const parallel::Triangulation<dim, spacedim> *>
-    (&mg_dof.get_tria());
+    (&mg_dof.get_triangulation());
   const MPI_Comm mpi_communicator = ptria != nullptr ? ptria->get_communicator() :
                                     MPI_COMM_SELF;
 
index a619124789214066d97d9f0ed90f045c36fa488a..fc31234f26c4d13b27f87995625f5ae5ad0e725c 100644 (file)
@@ -44,7 +44,7 @@ SolutionTransfer(const DoFHandlerType &dof)
   prepared_for(none)
 {
   Assert ((dynamic_cast<const parallel::distributed::Triangulation<DoFHandlerType::dimension, DoFHandlerType::space_dimension>*>
-           (&dof_handler->get_tria())
+           (&dof_handler->get_triangulation())
            == nullptr),
           ExcMessage ("You are calling the dealii::SolutionTransfer class "
                       "with a DoF handler that is built on a "

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.