From 1e88b5536929514e4ea7d14ef2fb6a32a0dfdca3 Mon Sep 17 00:00:00 2001 From: Guido Kanschat Date: Fri, 3 Jan 2014 17:49:10 +0000 Subject: [PATCH] remove one big field git-svn-id: https://svn.dealii.org/trunk@32161 0785d39b-7218-0410-832d-ea1e28bc413d --- .../deal.II/multigrid/mg_constrained_dofs.h | 55 +------------------ deal.II/source/multigrid/mg_transfer_block.cc | 2 +- 2 files changed, 2 insertions(+), 55 deletions(-) diff --git a/deal.II/include/deal.II/multigrid/mg_constrained_dofs.h b/deal.II/include/deal.II/multigrid/mg_constrained_dofs.h index 610e0344a4..1b6df2b6e3 100644 --- a/deal.II/include/deal.II/multigrid/mg_constrained_dofs.h +++ b/deal.II/include/deal.II/multigrid/mg_constrained_dofs.h @@ -110,14 +110,6 @@ public: const std::vector > & get_boundary_indices () const; - /** - * Return the indices of dofs for each level that lie on the - * boundary of the domain. - */ - // TODO: remove - const std::vector > & - get_non_refinement_edge_indices () const; - /** * Return the indices of dofs for each level that lie on the * refinement edge (i.e. are on faces between cells of this level @@ -142,11 +134,6 @@ public: bool set_boundary_values () const; - /** - * Return if the finite element requires continuity across - * refinement edges. - */ - bool continuity_across_refinement_edges () const; private: /** @@ -154,12 +141,6 @@ private: */ std::vector > boundary_indices; - /** - * The degrees of freedom on egdges that are not a refinement edge - * between a level and coarser cells. - */ - std::vector > non_refinement_edge_indices; - /** * The degrees of freedom on the refinement edge between a level and * coarser cells. @@ -184,7 +165,6 @@ MGConstrainedDoFs::initialize(const DoFHandler &dof) const unsigned int nlevels = dof.get_tria().n_global_levels(); refinement_edge_indices.resize(nlevels); refinement_edge_boundary_indices.resize(nlevels); - non_refinement_edge_indices.resize(nlevels); for (unsigned int l=0; l &dof) } MGTools::extract_inner_interface_dofs (dof, refinement_edge_indices, refinement_edge_boundary_indices); - - MGTools::extract_non_interface_dofs (dof, non_refinement_edge_indices); } @@ -209,7 +187,6 @@ MGConstrainedDoFs::initialize( boundary_indices.resize(nlevels); refinement_edge_indices.resize(nlevels); refinement_edge_boundary_indices.resize(nlevels); - non_refinement_edge_indices.resize(nlevels); for (unsigned int l=0; l > & -MGConstrainedDoFs::get_non_refinement_edge_indices () const -{ - return non_refinement_edge_indices; -} - inline const std::vector > & MGConstrainedDoFs::get_refinement_edge_indices () const @@ -328,20 +289,6 @@ MGConstrainedDoFs::set_boundary_values () const return boundary_values_need_to_be_set; } -inline -bool -MGConstrainedDoFs::continuity_across_refinement_edges () const -{ - bool is_continuous = false; - for (unsigned int l=0; l