From caab3054fbe42559dd4d70e84edb54816183cd52 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Tue, 25 Apr 2017 16:35:32 -0600 Subject: [PATCH] Remove deprecated functions (hp::)DoFHandler::get_tria(). --- include/deal.II/dofs/dof_handler.h | 18 --------------- .../fe/fe_tools_extrapolate.templates.h | 22 +++++++++---------- include/deal.II/hp/dof_handler.h | 18 --------------- source/hp/dof_handler.cc | 10 ++++----- source/multigrid/mg_level_global_transfer.cc | 4 ++-- source/numerics/solution_transfer.cc | 2 +- 6 files changed, 19 insertions(+), 55 deletions(-) diff --git a/include/deal.II/dofs/dof_handler.h b/include/deal.II/dofs/dof_handler.h index c9b88b8148..c4fe7509d2 100644 --- a/include/deal.II/dofs/dof_handler.h +++ b/include/deal.II/dofs/dof_handler.h @@ -810,13 +810,6 @@ public: */ const FiniteElement &get_fe () const; - /** - * Return a constant reference to the triangulation underlying this object. - * - * @deprecated Use get_triangulation() instead. - */ - const Triangulation &get_tria () const DEAL_II_DEPRECATED; - /** * Return a constant reference to the triangulation underlying this object. */ @@ -1220,17 +1213,6 @@ DoFHandler::get_fe () const -template -inline -const Triangulation & -DoFHandler::get_tria () const -{ - Assert(tria != nullptr, ExcNotInitialized()); - return *tria; -} - - - template inline const Triangulation & diff --git a/include/deal.II/fe/fe_tools_extrapolate.templates.h b/include/deal.II/fe/fe_tools_extrapolate.templates.h index 23c7914575..cea9bffec0 100644 --- a/include/deal.II/fe/fe_tools_extrapolate.templates.h +++ b/include/deal.II/fe/fe_tools_extrapolate.templates.h @@ -728,7 +728,7 @@ namespace FETools { const parallel::distributed::Triangulation< dim, spacedim > *tr = (dynamic_cast*> - (&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*> - (&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*> - (&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 *parallel_tria = - dynamic_cast*>(&dh.get_tria()); + dynamic_cast*>(&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 *parallel_tria = - dynamic_cast*>(&dh.get_tria()); + dynamic_cast*>(&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 *parallel_tria = - dynamic_cast*>(&dh.get_tria()); + dynamic_cast*>(&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 &vector) { const parallel::distributed::Triangulation *parallel_tria = - dynamic_cast*>(&dh.get_tria()); + dynamic_cast*>(&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 *parallel_tria = - dynamic_cast*>(&dh.get_tria()); + dynamic_cast*>(&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 *parallel_tria = - dynamic_cast*>(&dh.get_tria()); + dynamic_cast*>(&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 &vector) { const parallel::distributed::Triangulation *parallel_tria = - dynamic_cast*>(&dh.get_tria()); + dynamic_cast*>(&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 u3; internal::reinit_distributed(dof2, u3); - if (dynamic_cast*>(&dof2.get_tria()) != nullptr) + if (dynamic_cast*>(&dof2.get_triangulation()) != nullptr) { interpolate(dof1, u1, dof2, constraints, u3); diff --git a/include/deal.II/hp/dof_handler.h b/include/deal.II/hp/dof_handler.h index 2be4054db8..cd1c5789e6 100644 --- a/include/deal.II/hp/dof_handler.h +++ b/include/deal.II/hp/dof_handler.h @@ -603,14 +603,6 @@ namespace hp */ const hp::FECollection &get_fe () const; - /** - * Return a constant reference to the triangulation underlying this - * object. - * - * @deprecated Use get_triangulation() instead. - */ - const Triangulation &get_tria () const DEAL_II_DEPRECATED; - /** * Return a constant reference to the triangulation underlying this * object. @@ -1050,16 +1042,6 @@ namespace hp - template - inline - const Triangulation & - DoFHandler::get_tria () const - { - return *tria; - } - - - template inline const Triangulation & diff --git a/source/hp/dof_handler.cc b/source/hp/dof_handler.cc index 7bdb99eb37..c2670a1a57 100644 --- a/source/hp/dof_handler.cc +++ b/source/hp/dof_handler.cc @@ -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 void DoFHandler::set_active_fe_indices (const std::vector &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 void DoFHandler::get_active_fe_indices (std::vector &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::fill_and_communicate_copy_indices } const parallel::Triangulation *ptria = dynamic_cast *> - (&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 >::fill_and_com // precisely the indices that we need) const parallel::Triangulation *ptria = dynamic_cast *> - (&mg_dof.get_tria()); + (&mg_dof.get_triangulation()); const MPI_Comm mpi_communicator = ptria != nullptr ? ptria->get_communicator() : MPI_COMM_SELF; diff --git a/source/numerics/solution_transfer.cc b/source/numerics/solution_transfer.cc index a619124789..fc31234f26 100644 --- a/source/numerics/solution_transfer.cc +++ b/source/numerics/solution_transfer.cc @@ -44,7 +44,7 @@ SolutionTransfer(const DoFHandlerType &dof) prepared_for(none) { Assert ((dynamic_cast*> - (&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 " -- 2.39.5