From c3b628b913651a58a2498dc545d377e89b8dbbc3 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Sun, 11 Jan 2015 19:31:44 -0600 Subject: [PATCH] Remove deprecated class MGDoFHandler. --- doc/news/changes.h | 25 ++- examples/step-50/step-50.cc | 1 - include/deal.II/dofs/dof_handler.h | 5 +- include/deal.II/dofs/dof_objects.h | 4 +- include/deal.II/dofs/dof_renumbering.h | 44 +---- include/deal.II/dofs/dof_tools.h | 1 - include/deal.II/fe/fe_values.h | 1 - include/deal.II/grid/grid_tools.h | 4 +- include/deal.II/grid/intergrid_map.h | 7 +- include/deal.II/grid/tria.h | 1 - include/deal.II/grid/tria_iterator.h | 11 +- include/deal.II/matrix_free/matrix_free.h | 35 +--- .../matrix_free/matrix_free.templates.h | 2 +- include/deal.II/meshworker/local_results.h | 2 +- include/deal.II/multigrid/mg_dof_handler.h | 149 ----------------- .../multigrid/mg_dof_iterator_selector.h | 151 ------------------ include/deal.II/multigrid/multigrid.h | 1 - include/deal.II/numerics/matrix_tools.h | 1 - source/dofs/block_info.cc | 1 - source/dofs/dof_renumbering.cc | 36 ----- source/dofs/dof_renumbering.inst.in | 40 ----- source/dofs/dof_tools.cc | 1 - source/dofs/dof_tools.inst.in | 86 +--------- source/dofs/dof_tools_constraints.cc | 19 --- source/dofs/dof_tools_constraints.inst.in | 8 - source/dofs/dof_tools_sparsity.cc | 1 - source/dofs/dof_tools_sparsity.inst.in | 17 -- source/grid/grid_tools.cc | 1 - source/grid/grid_tools.inst.in | 26 --- source/grid/intergrid_map.cc | 1 - source/multigrid/CMakeLists.txt | 4 +- source/multigrid/mg_dof_handler.cc | 107 ------------- source/multigrid/mg_dof_handler.inst.in | 30 ---- source/multigrid/mg_tools.cc | 1 - source/multigrid/mg_tools.inst.in | 9 -- source/multigrid/mg_transfer_block.cc | 1 - source/multigrid/mg_transfer_component.cc | 1 - source/multigrid/mg_transfer_prebuilt.cc | 1 - source/numerics/fe_field_function.cc | 1 - source/numerics/vector_tools_boundary.inst.in | 22 --- tests/benchmarks/old/dof_handler_size.cc | 2 +- tests/benchmarks/old/dof_handler_timing_01.cc | 2 +- .../benchmarks/old/patches/library/2007-05-30 | 4 +- .../bits/refine_and_coarsen_for_parents_03.cc | 7 +- tests/bits/step-16.cc | 8 +- tests/bits/step-16b.cc | 7 +- tests/deal.II/block_info.cc | 7 +- tests/deal.II/block_info_02.cc | 3 +- tests/deal.II/block_list.h | 1 - tests/deal.II/block_list_01.cc | 6 +- tests/deal.II/block_list_02.cc | 5 +- tests/deal.II/block_list_03.cc | 5 +- tests/deal.II/block_list_04.cc | 5 +- tests/deal.II/dof_renumbering.cc | 13 +- tests/deal.II/dof_renumbering_02.cc | 14 +- tests/deal.II/dof_renumbering_03.cc | 1 - tests/deal.II/dof_renumbering_04.cc | 1 - tests/deal.II/dof_renumbering_04a.cc | 1 - tests/deal.II/dof_renumbering_05.cc | 1 - tests/deal.II/dof_renumbering_06.cc | 1 - .../extract_dofs_by_component_02_mg.cc | 6 +- tests/deal.II/get_finest_common_cells_01.cc | 1 - tests/deal.II/get_finest_common_cells_02.cc | 1 - tests/deal.II/get_finest_common_cells_03.cc | 1 - tests/deal.II/get_finest_common_cells_04.cc | 9 +- tests/deal.II/have_same_coarse_mesh_01.cc | 1 - tests/deal.II/have_same_coarse_mesh_02.cc | 1 - tests/deal.II/have_same_coarse_mesh_03.cc | 1 - tests/deal.II/have_same_coarse_mesh_04.cc | 9 +- tests/deal.II/helmholtz.h | 2 +- tests/deal.II/helmholtz1mg.th | 4 +- tests/deal.II/mg_dof_handler.cc | 8 +- tests/fe/transfer.cc | 6 +- tests/hp/dof_renumbering_04.cc | 1 - tests/hp/dof_renumbering_05.cc | 1 - tests/hp/dof_renumbering_06.cc | 1 - tests/hp/renumber_block_wise_01.cc | 1 - tests/hp/renumber_block_wise_01a.cc | 1 - tests/hp/renumber_block_wise_01b.cc | 1 - tests/hp/renumber_block_wise_02.cc | 1 - tests/hp/renumber_component_wise.cc | 1 - .../assembler_simple_mgmatrix_03.cc | 15 +- .../assembler_simple_mgmatrix_04.cc | 5 +- tests/integrators/cells_and_faces_01.cc | 11 +- tests/integrators/functional_01.cc | 11 +- tests/integrators/mesh_worker_01.cc | 7 +- tests/integrators/mesh_worker_02.cc | 9 +- tests/integrators/mesh_worker_03.cc | 9 +- tests/mpi/flux_edge_01.cc | 1 - tests/mpi/mesh_worker_03.cc | 2 +- tests/mpi/multigrid_adaptive.cc | 3 +- tests/mpi/multigrid_uniform.cc | 3 +- tests/mpi/step-39.cc | 1 - tests/mpi/torus.cc | 1 - tests/multigrid/boundary_01.cc | 6 +- tests/multigrid/count_01.cc | 6 +- tests/multigrid/dof_01.cc | 12 +- tests/multigrid/dof_02.cc | 14 +- tests/multigrid/dof_03.cc | 5 +- tests/multigrid/mg_renumbered_01.cc | 31 ++-- tests/multigrid/mg_renumbered_02.cc | 26 +-- tests/multigrid/mg_renumbered_03.cc | 39 ++--- tests/multigrid/renumbering_01.cc | 17 +- tests/multigrid/renumbering_02.cc | 8 +- tests/multigrid/renumbering_03.cc | 10 +- tests/multigrid/step-16-02.cc | 16 +- tests/multigrid/step-16-bdry1.cc | 16 +- tests/multigrid/step-16.cc | 16 +- tests/multigrid/step-39-02.cc | 8 +- tests/multigrid/step-39-02a.cc | 8 +- tests/multigrid/step-39-03.cc | 8 +- tests/multigrid/step-39.cc | 8 +- tests/multigrid/transfer_01.cc | 8 +- tests/multigrid/transfer_02.cc | 8 +- tests/multigrid/transfer_03.cc | 27 ++-- tests/multigrid/transfer_block.cc | 8 +- tests/multigrid/transfer_block_select.cc | 8 +- tests/multigrid/transfer_compare_01.cc | 10 +- tests/multigrid/transfer_prebuilt_01.cc | 6 +- tests/multigrid/transfer_prebuilt_02.cc | 6 +- tests/multigrid/transfer_prebuilt_03.cc | 6 +- tests/multigrid/transfer_select.cc | 6 +- tests/multigrid/transfer_system_01.cc | 8 +- tests/multigrid/transfer_system_02.cc | 8 +- tests/multigrid/transfer_system_03.cc | 8 +- tests/multigrid/transfer_system_04.cc | 8 +- tests/multigrid/transfer_system_05.cc | 6 +- .../multigrid/transfer_system_adaptive_01.cc | 8 +- .../multigrid/transfer_system_adaptive_02.cc | 8 +- .../multigrid/transfer_system_adaptive_03.cc | 8 +- .../multigrid/transfer_system_adaptive_04.cc | 8 +- .../multigrid/transfer_system_adaptive_05.cc | 8 +- .../multigrid/transfer_system_adaptive_06.cc | 8 +- .../multigrid/transfer_system_adaptive_07.cc | 8 +- .../multigrid/transfer_system_adaptive_08.cc | 8 +- .../multigrid/transfer_system_adaptive_09.cc | 6 +- tests/trilinos/mg_transfer_prebuilt_01.cc | 6 +- 137 files changed, 391 insertions(+), 1159 deletions(-) delete mode 100644 include/deal.II/multigrid/mg_dof_handler.h delete mode 100644 include/deal.II/multigrid/mg_dof_iterator_selector.h delete mode 100644 source/multigrid/mg_dof_handler.cc delete mode 100644 source/multigrid/mg_dof_handler.inst.in diff --git a/doc/news/changes.h b/doc/news/changes.h index 880aafa1b6..2feac5d682 100644 --- a/doc/news/changes.h +++ b/doc/news/changes.h @@ -140,7 +140,30 @@ inconvenience this causes. - TrilinosWrappers::*Vector*::compress with an Epetra_CombineMode argument
- (Wolfgang Bangerth, 2014/12/29-2015/01/09) + This release also removes the deprecated class MGDoFHandler. The + functionality of this class had previously been incorporated into + the DoFHandler class. Unlike the changes above, if you were still + using this class, you will need to do the following changes to + your code: + - Where you called mg_dof_handler.distribute_dofs() + you now also need to explicitly call + mg_dof_handler.distribute_mg_dofs(). + - If you called mg_dof_handler.begin(level), you + will now have to write this as + mg_dof_handler.begin_mg(level) to make clear that + you are not just interested in an iterator to a cell on a given + level, but in fact to a cell that can access the degrees of + freedom on a particular level of a multigrid hierarchy. + - The type previously referred to as + MGDoFHandler::cell_iterator now corresponds to + MGDoFHandler::level_cell_iterator. + - Where you previously called DoFRenumbering::component_wise + for the entire MGDoFHandler object, you now need to call + this function for the DoFHandler object, and then call the + same function with the level argument for each + of the levels of the triangulation individually. +
+ (Wolfgang Bangerth, 2014/12/29-2015/01/11)
  • Removed: The config.h file no longer exports HAVE_* definitions. diff --git a/examples/step-50/step-50.cc b/examples/step-50/step-50.cc index e4fc0ba5de..c91a37cf0a 100644 --- a/examples/step-50/step-50.cc +++ b/examples/step-50/step-50.cc @@ -93,7 +93,6 @@ // The rest of the include files deals with // the mechanics of multigrid as a linear // operator (solver or preconditioner). -#include #include #include #include diff --git a/include/deal.II/dofs/dof_handler.h b/include/deal.II/dofs/dof_handler.h index e2bd6a6da0..2f1b392e26 100644 --- a/include/deal.II/dofs/dof_handler.h +++ b/include/deal.II/dofs/dof_handler.h @@ -344,8 +344,6 @@ public: * multigrid. The active DoFs need to be distributed using distribute_dofs() * before calling this function and the @p fe needs to be identical to the * finite element passed to distribute_dofs(). - * - * This replaces the functionality of the old MGDoFHandler. */ virtual void distribute_mg_dofs (const FiniteElement &fe); @@ -727,7 +725,8 @@ public: * * At the end of distribute_dofs(), the number of degrees of freedom in each * block is counted, and stored in a BlockInfo object, which can be accessed - * here. In an MGDoFHandler, the same is done on each level. Additionally, + * here. If you have previously called distribute_mg_dofs(), + * the same is done on each level of the multigrid hierarchy. Additionally, * the block structure on each cell can be generated in this object by * calling initialize_local_block_info(). */ diff --git a/include/deal.II/dofs/dof_objects.h b/include/deal.II/dofs/dof_objects.h index 2adab75f92..7fd4b1420c 100644 --- a/include/deal.II/dofs/dof_objects.h +++ b/include/deal.II/dofs/dof_objects.h @@ -142,8 +142,8 @@ namespace internal const unsigned int version); /** - * Make the DoFHandler and MGDoFHandler classes a friend, so that they - * can resize arrays as necessary. + * Declare the classes that store levels and faces of DoFs + * friends so that they can resize arrays. */ template friend class DoFLevel; template friend class DoFFaces; diff --git a/include/deal.II/dofs/dof_renumbering.h b/include/deal.II/dofs/dof_renumbering.h index 999ab64690..c7c1836b0f 100644 --- a/include/deal.II/dofs/dof_renumbering.h +++ b/include/deal.II/dofs/dof_renumbering.h @@ -22,7 +22,6 @@ #include #include #include -#include #include @@ -594,10 +593,6 @@ namespace DoFRenumbering * * For finite elements with only one component, or a single non-primitive * base element, this function is the identity operation. - * - * @note A similar function, which renumbered all levels existed for - * MGDoFHandler. This function was deleted. Thus, you have to call the level - * function for each level now. */ template void @@ -618,7 +613,7 @@ namespace DoFRenumbering /** * Sort the degrees of freedom by component. It does the same thing as the * above function, only that it does this for one single level of a multi- - * level discretization. The non-multigrid part of the MGDoFHandler is not + * level discretization. The non-multigrid part of the the DoFHandler is not * touched. */ template @@ -627,17 +622,6 @@ namespace DoFRenumbering const unsigned int level, const std::vector &target_component = std::vector()); - - /** - * Sort the degrees of freedom by component. It does the same thing as the - * previous functions, but more: it renumbers not only every level of the - * multigrid part, but also the global, i.e. non-multigrid components. - */ - template - void - component_wise (MGDoFHandler &dof_handler, - const std::vector &target_component = std::vector()); - /** * Computes the renumbering vector needed by the component_wise() functions. * Does not perform the renumbering on the DoFHandler dofs but returns the @@ -692,27 +676,6 @@ namespace DoFRenumbering void block_wise (hp::DoFHandler &dof_handler); - /** - * Sort the degrees of freedom by block. It does the same thing as the above - * function, only that it does this for one single level of a multi-level - * discretization. The non-multigrid part of the MGDoFHandler is not - * touched. - */ - template - void - block_wise (MGDoFHandler &dof_handler, - const unsigned int level); - - - /** - * Sort the degrees of freedom by block. It does the same thing as the - * previous functions, but more: it renumbers not only every level of the - * multigrid part, but also the global, i.e. non-multigrid components. - */ - template - void - block_wise (MGDoFHandler &dof_handler); - /** * Computes the renumbering vector needed by the block_wise() functions. * Does not perform the renumbering on the DoFHandler dofs but returns the @@ -960,9 +923,10 @@ namespace DoFRenumbering const std::vector &selected_dofs); /** - * Computes the renumbering vector on each level needed by the + * This function computes the renumbering vector on each level needed by the * sort_selected_dofs_back() function. Does not perform the renumbering on - * the MGDoFHandler dofs but returns the renumbering vector. + * the DoFHandler dofs but only computes the renumbering and returns + * the renumbering vector. * * @pre The @p selected_dofs array must have as many elements as the @p * dof_handler has degrees of freedom on the given level. diff --git a/include/deal.II/dofs/dof_tools.h b/include/deal.II/dofs/dof_tools.h index a545b4c5fa..259d1e4721 100644 --- a/include/deal.II/dofs/dof_tools.h +++ b/include/deal.II/dofs/dof_tools.h @@ -47,7 +47,6 @@ namespace hp template class DoFHandler; template class MappingCollection; } -template class MGDoFHandler; class ConstraintMatrix; template class InterGridMap; template class Mapping; diff --git a/include/deal.II/fe/fe_values.h b/include/deal.II/fe/fe_values.h index 37278865a6..5addb77fcc 100644 --- a/include/deal.II/fe/fe_values.h +++ b/include/deal.II/fe/fe_values.h @@ -35,7 +35,6 @@ #include #include #include -#include #include #include diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index fc342de97c..5946c65fed 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -707,7 +707,7 @@ namespace GridTools /** * Given two mesh containers (i.e. objects of type Triangulation, - * DoFHandler, hp::DoFHandler, or MGDoFHandler) that are based on the same + * DoFHandler, or hp::DoFHandler) that are based on the same * coarse mesh, this function figures out a set of cells that are matched * between the two meshes and where at most one of the meshes is more * refined on this cell. In other words, it finds the smallest cells that @@ -756,7 +756,7 @@ namespace GridTools /** * The same function as above, but working on arguments of type DoFHandler, - * hp::DoFHandler, or MGDoFHandler. This function is provided to allow + * or hp::DoFHandler. This function is provided to allow * calling have_same_coarse_mesh for all types of containers representing * triangulations or the classes built on triangulations. * diff --git a/include/deal.II/grid/intergrid_map.h b/include/deal.II/grid/intergrid_map.h index e8f52b897a..948487c885 100644 --- a/include/deal.II/grid/intergrid_map.h +++ b/include/deal.II/grid/intergrid_map.h @@ -68,12 +68,12 @@ DEAL_II_NAMESPACE_OPEN * * The implementation of this class is such that not only cell iterators into * triangulations can be mapped, but also iterators into objects of type - * DoFHandler, hp::DoFHandler and MGDoFHandler. The extension to other classes + * DoFHandler or hp::DoFHandler. The extension to other classes * offering iterator functions and some minor additional requirements is * simple. * * Note that this class could in principle be based on the C++ - * map data type. Instead, it uses another data format + * std::map data type. Instead, it uses another data format * which is more effective both in terms of computing time for access as well * as with regard to memory consumpion. * @@ -107,8 +107,7 @@ DEAL_II_NAMESPACE_OPEN * * Note that the template parameters to this class have to be given as * InterGridMap >, which here is DoFHandler (and could - * equally well be Triangulation, PersistentTriangulation, hp::DoFHandler or - * MGDoFHandler). + * equally well be Triangulation, PersistentTriangulation, or hp::DoFHandler). * * @ingroup grid * @author Wolfgang Bangerth, 1999 diff --git a/include/deal.II/grid/tria.h b/include/deal.II/grid/tria.h index 54c0135419..d8abc8c85d 100644 --- a/include/deal.II/grid/tria.h +++ b/include/deal.II/grid/tria.h @@ -76,7 +76,6 @@ namespace hp { template class DoFHandler; } -template class MGDoFHandler; /*------------------------------------------------------------------------*/ diff --git a/include/deal.II/grid/tria_iterator.h b/include/deal.II/grid/tria_iterator.h index 79578f7f48..c8fae28017 100644 --- a/include/deal.II/grid/tria_iterator.h +++ b/include/deal.II/grid/tria_iterator.h @@ -161,11 +161,12 @@ template class TriaActiveIterator; * but you may write your own version (non-virtual, since we use templates) to * add functionality. * - * The accessors provided by the library are distributed in three groups, - * determined by whether they access the data of Triangulation, DoFHandler or - * MGDoFHandler. They are derived from TriaAccessor, DoFAccessor and - * MGDoFAccessor, respectively. In each group, there is an accessor to cells, - * which have more functionality. + * The accessors provided by the library consists of two groups, + * determined by whether they access the data of Triangulation objects or + * DoFHandler/hp::DoFHandler objects. They are derived from TriaAccessor and + * DoFAccessor, respectively. Each group also has specialized accessors for + * cells (as opposed to faces and lines) that offer more functionality such as + * accessing neighbors. * * @attention It seems impossible to preserve constness of a triangulation * through iterator usage. Thus, if you declare pointers to a const diff --git a/include/deal.II/matrix_free/matrix_free.h b/include/deal.II/matrix_free/matrix_free.h index 50cf0506af..c0222571ac 100644 --- a/include/deal.II/matrix_free/matrix_free.h +++ b/include/deal.II/matrix_free/matrix_free.h @@ -30,7 +30,6 @@ #include #include #include -#include #include #include #include @@ -1583,38 +1582,6 @@ reinit(const Mapping &mapping, -namespace internal -{ - namespace MatrixFree - { - // resolve DoFHandler types - - // MGDoFHandler is deprecated in deal.II but might still be present in - // user code, so we need to resolve its type (fortunately, it is derived - // from DoFHandler, so we can static_cast it to a DoFHandler) - template - inline - std::vector *> - resolve_dof_handler (const std::vector &dof_handler) - { - std::vector *> conversion(dof_handler.size()); - for (unsigned int i=0; i *>(dof_handler[i]); - return conversion; - } - - template - inline - std::vector *> - resolve_dof_handler (const std::vector *> &dof_handler) - { - return dof_handler; - } - } -} - - - template template void MatrixFree:: @@ -1630,7 +1597,7 @@ reinit(const Mapping &mapping, for (unsigned int q=0; q(quad[q])); internal_reinit (mapping, - internal::MatrixFree::resolve_dof_handler(dof_handler), + dof_handler, constraint, locally_owned_set, quad_hp, additional_data); } diff --git a/include/deal.II/matrix_free/matrix_free.templates.h b/include/deal.II/matrix_free/matrix_free.templates.h index 45944812cf..eafe233f0f 100644 --- a/include/deal.II/matrix_free/matrix_free.templates.h +++ b/include/deal.II/matrix_free/matrix_free.templates.h @@ -573,7 +573,7 @@ void MatrixFree::initialize_indices constraint_values, cell_at_boundary); } - // ok, now we are requested to use a level in a MGDoFHandler + // ok, now we are requested to use a level in a MG DoFHandler else if (dof_handlers.active_dof_handler == DoFHandlers::usual && dof_handlers.level != numbers::invalid_unsigned_int) { diff --git a/include/deal.II/meshworker/local_results.h b/include/deal.II/meshworker/local_results.h index 94538f915c..880f54e552 100644 --- a/include/deal.II/meshworker/local_results.h +++ b/include/deal.II/meshworker/local_results.h @@ -28,7 +28,7 @@ DEAL_II_NAMESPACE_OPEN class BlockIndices; template class DoFHandler; -template class MGDoFHandler; + /** * A collection of functions and classes for the mesh loops that are an diff --git a/include/deal.II/multigrid/mg_dof_handler.h b/include/deal.II/multigrid/mg_dof_handler.h deleted file mode 100644 index b0970bc909..0000000000 --- a/include/deal.II/multigrid/mg_dof_handler.h +++ /dev/null @@ -1,149 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 1998 - 2013 by the deal.II authors -// -// This file is part of the deal.II library. -// -// The deal.II library is free software; you can use it, redistribute -// it, and/or modify it under the terms of the GNU Lesser General -// Public License as published by the Free Software Foundation; either -// version 2.1 of the License, or (at your option) any later version. -// The full text of the license can be found in the file LICENSE at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - -#ifndef __deal2__mg_dof_handler_h -#define __deal2__mg_dof_handler_h - -//TODO: MgDoFHandler should be marked deprecated, but is used everywhere... -//#warning MGDoFHandler is deprecated - -#include -#include -//#include - -DEAL_II_NAMESPACE_OPEN - - -namespace internal -{ - namespace MGDoFHandler - { - struct Implementation; - } -} - - -/*!@addtogroup mg */ -/*@{*/ - - -/** - * @deprecated All functionality of this class has been moved to DoFHandler. - * Thus, this class is only a wrapper left in the library for compatibility - * reasons. - * - * This class manages degrees of freedom for a multilevel hierarchy of grids. - * It does mostly the same as does the @p DoDHandler class, but it uses a - * separate enumeration of the degrees of freedom on each level. For example, - * a vertex has several DoF numbers, one for each level of the triangulation - * on which it exists. - * - * @todo This class has not yet been implemented for the use in the - * codimension one case (spacedim != dim ). - * - * @ingroup dofs - * @author Wolfgang Bangerth, 1998, 1999 Markus Bürg, Timo Heister, Guido - * Kanschat, 2012 - */ -template -class MGDoFHandler : public DoFHandler -{ - typedef dealii::internal::DoFHandler::Iterators, true> IteratorSelector; -public: - typedef typename IteratorSelector::CellAccessor cell_accessor; - typedef typename IteratorSelector::FaceAccessor face_accessor; - - typedef typename IteratorSelector::raw_line_iterator raw_line_iterator; - typedef typename IteratorSelector::line_iterator line_iterator; - typedef typename IteratorSelector::active_line_iterator active_line_iterator; - - typedef typename IteratorSelector::quad_iterator quad_iterator; - typedef typename IteratorSelector::active_quad_iterator active_quad_iterator; - - typedef typename IteratorSelector::hex_iterator hex_iterator; - typedef typename IteratorSelector::active_hex_iterator active_hex_iterator; - - typedef typename IteratorSelector::cell_iterator cell_iterator; - typedef typename IteratorSelector::active_cell_iterator active_cell_iterator; - - typedef typename IteratorSelector::face_iterator face_iterator; - typedef typename IteratorSelector::active_face_iterator active_face_iterator; - - /** - * Make the dimension and the space_dimension available in function - * templates. - */ - static const unsigned int dimension = dim; - - static const unsigned int space_dimension = spacedim; - - /** - * Default constructor, which will require a call to initialize() later to - * set the Triangulation. - */ - MGDoFHandler (); - - /** - * Constructor. Take @p tria as the triangulation to work on. - */ - MGDoFHandler (const Triangulation &tria); - - /** - * Destructor - */ - virtual ~MGDoFHandler (); - - /** - * Go through the triangulation and distribute the degrees of freedoms - * needed for the given finite element according to the given distribution - * method. We first call the DoFHandler's function and then distribute the - * levelwise numbers. - * - * A copy of the transferred finite element is stored. - */ - virtual void distribute_dofs (const FiniteElement &); - - /** - * @name Cell iterator functions - */ - /*@{*/ - /** - * Iterator to the first used cell on level @p level. - */ - cell_iterator begin (const unsigned int level = 0) const; - - /** - * Iterator past the end; this iterator serves for comparisons of iterators - * with past-the-end or before-the-beginning states. - */ - cell_iterator end () const; - - /** - * Return an iterator which is the first iterator not on level. If @p level - * is the last level, then this returns end(). - */ - cell_iterator end (const unsigned int level) const; - - //@} - -} DEAL_II_DEPRECATED; - -/*@}*/ - - -DEAL_II_NAMESPACE_CLOSE - - -#endif diff --git a/include/deal.II/multigrid/mg_dof_iterator_selector.h b/include/deal.II/multigrid/mg_dof_iterator_selector.h deleted file mode 100644 index cf39a9c26d..0000000000 --- a/include/deal.II/multigrid/mg_dof_iterator_selector.h +++ /dev/null @@ -1,151 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 1998 - 2013 by the deal.II authors -// -// This file is part of the deal.II library. -// -// The deal.II library is free software; you can use it, redistribute -// it, and/or modify it under the terms of the GNU Lesser General -// Public License as published by the Free Software Foundation; either -// version 2.1 of the License, or (at your option) any later version. -// The full text of the license can be found in the file LICENSE at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - -#ifndef __deal2__mg_dof_iterator_selector_h -#define __deal2__mg_dof_iterator_selector_h - - -#include - - -DEAL_II_NAMESPACE_OPEN - -template class MGDoFAccessor; -template class MGDoFCellAccessor; -template class InvalidAccessor; - -template class TriaRawIterator; -template class TriaIterator; -template class TriaActiveIterator; - - -namespace internal -{ - namespace MGDoFHandler - { - template - class Iterators; - - - /** - * Iterators for MGDofHandler in one dimension. See the - * @ref Iterators - * module for more information. - */ - template - class Iterators<1,spacedim> - { - public: - typedef dealii::MGDoFCellAccessor<1,spacedim> CellAccessor; - typedef dealii::MGDoFAccessor<0,1,spacedim> FaceAccessor; - - typedef TriaRawIterator raw_line_iterator; - typedef TriaIterator line_iterator; - typedef TriaActiveIterator active_line_iterator; - - typedef TriaRawIterator > raw_quad_iterator; - typedef TriaIterator > quad_iterator; - typedef TriaActiveIterator > active_quad_iterator; - - typedef TriaRawIterator > raw_hex_iterator; - typedef TriaIterator > hex_iterator; - typedef TriaActiveIterator > active_hex_iterator; - - typedef raw_line_iterator raw_cell_iterator; - typedef line_iterator cell_iterator; - typedef active_line_iterator active_cell_iterator; - - typedef TriaRawIterator raw_face_iterator; - typedef TriaIterator face_iterator; - typedef TriaActiveIterator active_face_iterator; - }; - - - - /** - * Iterators for MGDofHandler in two dimensions. See the - * @ref Iterators - * module for more information. - */ - template - class Iterators<2,spacedim> - { - public: - typedef dealii::MGDoFCellAccessor<2,spacedim> CellAccessor; - typedef dealii::MGDoFAccessor<1,2,spacedim> FaceAccessor; - - typedef TriaRawIterator raw_line_iterator; - typedef TriaIterator line_iterator; - typedef TriaActiveIterator active_line_iterator; - - typedef TriaRawIterator raw_quad_iterator; - typedef TriaIterator quad_iterator; - typedef TriaActiveIterator active_quad_iterator; - - typedef TriaRawIterator > raw_hex_iterator; - typedef TriaIterator > hex_iterator; - typedef TriaActiveIterator > active_hex_iterator; - - typedef raw_quad_iterator raw_cell_iterator; - typedef quad_iterator cell_iterator; - typedef active_quad_iterator active_cell_iterator; - - typedef raw_line_iterator raw_face_iterator; - typedef line_iterator face_iterator; - typedef active_line_iterator active_face_iterator; - }; - - - - /** - * Iterators for MGDofHandler in three dimensions. See the - * @ref Iterators - * module for more information. - */ - template - class Iterators<3,spacedim> - { - public: - typedef dealii::MGDoFCellAccessor<3,spacedim> CellAccessor; - typedef dealii::MGDoFAccessor<2,3,spacedim> FaceAccessor; - - typedef TriaRawIterator > raw_line_iterator; - typedef TriaIterator > line_iterator; - typedef TriaActiveIterator > active_line_iterator; - - typedef TriaRawIterator raw_quad_iterator; - typedef TriaIterator quad_iterator; - typedef TriaActiveIterator active_quad_iterator; - - typedef TriaRawIterator raw_hex_iterator; - typedef TriaIterator hex_iterator; - typedef TriaActiveIterator active_hex_iterator; - - typedef raw_hex_iterator raw_cell_iterator; - typedef hex_iterator cell_iterator; - typedef active_hex_iterator active_cell_iterator; - - typedef raw_quad_iterator raw_face_iterator; - typedef quad_iterator face_iterator; - typedef active_quad_iterator active_face_iterator; - }; - } -} - - -DEAL_II_NAMESPACE_CLOSE - -#endif -/*---------------------------- mg_dof_iterator_selector.h ---------------------------*/ diff --git a/include/deal.II/multigrid/multigrid.h b/include/deal.II/multigrid/multigrid.h index f4df66f6f3..e9fe9831f7 100644 --- a/include/deal.II/multigrid/multigrid.h +++ b/include/deal.II/multigrid/multigrid.h @@ -25,7 +25,6 @@ #include #include #include -#include #include diff --git a/include/deal.II/numerics/matrix_tools.h b/include/deal.II/numerics/matrix_tools.h index 71afd6ae47..10dd190f90 100644 --- a/include/deal.II/numerics/matrix_tools.h +++ b/include/deal.II/numerics/matrix_tools.h @@ -42,7 +42,6 @@ template class BlockVector; template class Mapping; template class DoFHandler; -template class MGDoFHandler; template class FEValues; namespace hp diff --git a/source/dofs/block_info.cc b/source/dofs/block_info.cc index d7d883178d..4842e30f82 100644 --- a/source/dofs/block_info.cc +++ b/source/dofs/block_info.cc @@ -16,7 +16,6 @@ #include #include #include -#include #include #include #include diff --git a/source/dofs/dof_renumbering.cc b/source/dofs/dof_renumbering.cc index f1f986a5de..9a6cfff39f 100644 --- a/source/dofs/dof_renumbering.cc +++ b/source/dofs/dof_renumbering.cc @@ -550,17 +550,6 @@ namespace DoFRenumbering // component_wise(dof_handler, level, component_order_arg); } - // This function is only for compatibility reasons and will vanish in 8.0 - template - void - component_wise (MGDoFHandler &dof_handler, - const std::vector &component_order_arg) - { - DoFHandler &active_dof = dof_handler; - component_wise(active_dof, component_order_arg); - for (unsigned int level=0; level @@ -961,31 +950,6 @@ namespace DoFRenumbering - template - void - block_wise (MGDoFHandler &dof_handler) - { - // renumber the non-MG part of - // the DoFHandler in parallel to - // the MG part. Because - // MGDoFHandler::renumber_dofs - // uses the user flags we can't - // run renumbering on individual - // levels in parallel to the - // other levels - void (*non_mg_part) (DoFHandler &) - = &block_wise; - Threads::Task<> - task = Threads::new_task (non_mg_part, dof_handler); - - for (unsigned int level=0; level types::global_dof_index compute_block_wise (std::vector &new_indices, diff --git a/source/dofs/dof_renumbering.inst.in b/source/dofs/dof_renumbering.inst.in index e4a7060fd8..fda48f7efd 100644 --- a/source/dofs/dof_renumbering.inst.in +++ b/source/dofs/dof_renumbering.inst.in @@ -160,17 +160,6 @@ namespace DoFRenumbering unsigned int, const std::vector&); - template - void component_wise - (MGDoFHandler&, - const std::vector&); - - template - void component_wise - (MGDoFHandler&, - unsigned int, - const std::vector&); - template void block_wise (hp::DoFHandler&); @@ -236,13 +225,6 @@ namespace DoFRenumbering const hp::DoFHandler&, const std::vector::active_cell_iterator>&); - template void - downstream > - (MGDoFHandler&, - unsigned int, - const Point&, - const bool); - template void compute_downstream > (std::vector&,std::vector&, @@ -296,12 +278,6 @@ namespace DoFRenumbering (DoFHandler &, const std::vector &); - template - void sort_selected_dofs_back > - (MGDoFHandler &, - const std::vector &, - const unsigned int); - template void compute_sort_selected_dofs_back > @@ -309,14 +285,6 @@ namespace DoFRenumbering const DoFHandler &, const std::vector &); - template - void - compute_sort_selected_dofs_back > - (std::vector&, - const MGDoFHandler &, - const std::vector &, - const unsigned int); - template void random > (hp::DoFHandler &); @@ -350,14 +318,6 @@ namespace DoFRenumbering const unsigned int, const bool, const std::vector&); - - template - void Cuthill_McKee > - (MGDoFHandler&, - const unsigned int, - const bool, - const std::vector&); - \} // namespace DoFRenumbering #endif } diff --git a/source/dofs/dof_tools.cc b/source/dofs/dof_tools.cc index 1a6e7c6582..c49012d927 100644 --- a/source/dofs/dof_tools.cc +++ b/source/dofs/dof_tools.cc @@ -40,7 +40,6 @@ #include #include -#include #include #include diff --git a/source/dofs/dof_tools.inst.in b/source/dofs/dof_tools.inst.in index e7a596b26d..3bfb331ffe 100644 --- a/source/dofs/dof_tools.inst.in +++ b/source/dofs/dof_tools.inst.in @@ -23,11 +23,7 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS) template void DoFTools::make_cell_patches,SP> (SP&, const DoFHandler&, const unsigned int, const std::vector&, types::global_dof_index); - - template void - DoFTools::make_cell_patches,SP> - (SP&, const MGDoFHandler&, const unsigned int, const std::vector&, types::global_dof_index); -} + } @@ -54,19 +50,6 @@ for (deal_II_dimension : DIMENSIONS) void DoFTools::make_child_patches(SparsityPattern&, const DoFHandler&, unsigned int, bool, bool); - template - void DoFTools::make_vertex_patches (SparsityPattern&, const MGDoFHandler&, - unsigned int, bool, bool, bool, bool); - - template - void DoFTools::make_single_patch (SparsityPattern&, const MGDoFHandler&, - unsigned int, bool); - - template - void DoFTools::make_child_patches(SparsityPattern&, const MGDoFHandler&, - unsigned int, bool, bool); - - // TODO: can cleanup a bit more to fit into the scheme used above template @@ -148,18 +131,6 @@ template void DoFTools::extract_level_dofs > std::vector&); #endif -template void DoFTools::extract_level_dofs > -(const unsigned int level, - const MGDoFHandler&, - const ComponentMask &, - std::vector&); - -template void DoFTools::extract_level_dofs > -(const unsigned int level, - const MGDoFHandler&, - const BlockMask &, - std::vector&); - template void DoFTools::extract_boundary_dofs > @@ -465,24 +436,6 @@ DoFTools::count_dofs_with_subdomain_association > -template -unsigned int -DoFTools::count_dofs_with_subdomain_association > -(const MGDoFHandler &, - const types::subdomain_id); -template -IndexSet -DoFTools::dof_indices_with_subdomain_association > -(const MGDoFHandler &, - const types::subdomain_id); -template -void -DoFTools::count_dofs_with_subdomain_association > -(const MGDoFHandler &, - const types::subdomain_id, - std::vector &); - - template void DoFTools::count_dofs_per_component > ( @@ -517,14 +470,6 @@ DoFTools::extract_level_dofs const ComponentMask&, std::vector&); -template -void -DoFTools::extract_level_dofs > -(const unsigned int level, - const MGDoFHandler&, - const BlockMask&, - std::vector&); - #endif @@ -549,14 +494,6 @@ DoFTools::extract_level_dofs > const ComponentMask &, std::vector&); -template -void -DoFTools::extract_level_dofs > -(const unsigned int level, - const MGDoFHandler<1,3>&, - const BlockMask &, - std::vector&); - #endif @@ -574,13 +511,6 @@ DoFTools::count_dofs_per_block > ( std::vector&, const std::vector &); -template -void -DoFTools::count_dofs_per_block > ( - const MGDoFHandler&, - std::vector&, - const std::vector &); - template void DoFTools::map_dof_to_boundary_indices > @@ -687,13 +617,6 @@ DoFTools::count_dofs_per_block&, const std::vector &); -template -void -DoFTools::count_dofs_per_block > ( - const MGDoFHandler&, - std::vector&, - const std::vector &); - #endif @@ -720,13 +643,6 @@ DoFTools::count_dofs_per_block > ( std::vector&, const std::vector &); -template -void -DoFTools::count_dofs_per_block > ( - const MGDoFHandler<1,3>&, - std::vector&, - const std::vector &); - #endif template diff --git a/source/dofs/dof_tools_constraints.cc b/source/dofs/dof_tools_constraints.cc index 615c4d00d4..b4a7f31e8e 100644 --- a/source/dofs/dof_tools_constraints.cc +++ b/source/dofs/dof_tools_constraints.cc @@ -34,7 +34,6 @@ #include #include -#include #include #include @@ -632,24 +631,6 @@ namespace DoFTools } - void - make_hp_hanging_node_constraints (const dealii::MGDoFHandler<1> &, - ConstraintMatrix &) - { - // nothing to do for regular dof handlers in 1d - } - - - - void - make_oldstyle_hanging_node_constraints (const dealii::MGDoFHandler<1> &, - ConstraintMatrix &, - dealii::internal::int2type<1>) - { - // nothing to do for regular dof handlers in 1d - } - - void make_hp_hanging_node_constraints (const dealii::hp::DoFHandler<1> &/*dof_handler*/, ConstraintMatrix &/*constraints*/) diff --git a/source/dofs/dof_tools_constraints.inst.in b/source/dofs/dof_tools_constraints.inst.in index 3017a6d0b0..a15f54b6b2 100644 --- a/source/dofs/dof_tools_constraints.inst.in +++ b/source/dofs/dof_tools_constraints.inst.in @@ -82,14 +82,6 @@ for (DH : DOFHANDLERS; deal_II_dimension : DIMENSIONS) for (deal_II_dimension : DIMENSIONS) { -#if deal_II_dimension != 1 - template - void - DoFTools::make_hanging_node_constraints (const MGDoFHandler &dof_handler, - ConstraintMatrix &constraints); - -#endif - #if deal_II_dimension < 3 template diff --git a/source/dofs/dof_tools_sparsity.cc b/source/dofs/dof_tools_sparsity.cc index 5453d1b4f4..d1d24254ce 100644 --- a/source/dofs/dof_tools_sparsity.cc +++ b/source/dofs/dof_tools_sparsity.cc @@ -41,7 +41,6 @@ #include #include -#include #include #include diff --git a/source/dofs/dof_tools_sparsity.inst.in b/source/dofs/dof_tools_sparsity.inst.in index 2f8570c590..e60cebf3fb 100644 --- a/source/dofs/dof_tools_sparsity.inst.in +++ b/source/dofs/dof_tools_sparsity.inst.in @@ -33,14 +33,6 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS) const bool, const unsigned int); - template void - DoFTools::make_sparsity_pattern, SP> - (const MGDoFHandler &dof, - SP &sparsity, - const ConstraintMatrix &, - const bool, - const unsigned int); - template void DoFTools::make_sparsity_pattern, SP> (const DoFHandler&, @@ -59,15 +51,6 @@ for (SP : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS) const bool, const unsigned int); - template void - DoFTools::make_sparsity_pattern, SP> - (const MGDoFHandler&, - const Table<2,Coupling>&, - SP &, - const ConstraintMatrix &, - const bool, - const unsigned int); - template void DoFTools::make_sparsity_pattern, SP> (const DoFHandler &dof_row, diff --git a/source/grid/grid_tools.cc b/source/grid/grid_tools.cc index e9f7bf5ee0..75978de290 100644 --- a/source/grid/grid_tools.cc +++ b/source/grid/grid_tools.cc @@ -42,7 +42,6 @@ #include #include #include -#include #include #include diff --git a/source/grid/grid_tools.inst.in b/source/grid/grid_tools.inst.in index 717981f487..608e1ed5dd 100644 --- a/source/grid/grid_tools.inst.in +++ b/source/grid/grid_tools.inst.in @@ -15,16 +15,6 @@ -for (deal_II_dimension : DIMENSIONS) - { - namespace GridTools \{ - template - std::list::cell_iterator, MGDoFHandler::cell_iterator> > - get_finest_common_cells (const MGDoFHandler &mesh_1, - const MGDoFHandler &mesh_2); - \} - } - for (X : TRIANGULATION_AND_DOFHANDLERS; deal_II_dimension : DIMENSIONS ; deal_II_space_dimension : SPACE_DIMENSIONS) { @@ -127,22 +117,6 @@ for (deal_II_space_dimension : SPACE_DIMENSIONS) } -for (deal_II_dimension : DIMENSIONS ; deal_II_space_dimension : SPACE_DIMENSIONS) -{ - -#if deal_II_dimension <= deal_II_space_dimension - namespace GridTools \{ - template - bool - have_same_coarse_mesh (const MGDoFHandler &mesh_1, - const MGDoFHandler &mesh_2); - - \} - - #endif -} - - for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS) { #if deal_II_dimension <= deal_II_space_dimension diff --git a/source/grid/intergrid_map.cc b/source/grid/intergrid_map.cc index 3dd681126f..d4c260b7d6 100644 --- a/source/grid/intergrid_map.cc +++ b/source/grid/intergrid_map.cc @@ -23,7 +23,6 @@ #include #include -#include DEAL_II_NAMESPACE_OPEN diff --git a/source/multigrid/CMakeLists.txt b/source/multigrid/CMakeLists.txt index 9fa85ba667..4ba331d4cd 100644 --- a/source/multigrid/CMakeLists.txt +++ b/source/multigrid/CMakeLists.txt @@ -1,6 +1,6 @@ ## --------------------------------------------------------------------- ## -## Copyright (C) 2012 - 2013 by the deal.II authors +## Copyright (C) 2012 - 2013, 2015 by the deal.II authors ## ## This file is part of the deal.II library. ## @@ -17,7 +17,6 @@ INCLUDE_DIRECTORIES(BEFORE ${CMAKE_CURRENT_BINARY_DIR}) SET(_src mg_base.cc - mg_dof_handler.cc mg_tools.cc mg_transfer_block.cc mg_transfer_component.cc @@ -27,7 +26,6 @@ SET(_src SET(_inst mg_base.inst.in - mg_dof_handler.inst.in mg_tools.inst.in mg_transfer_block.inst.in mg_transfer_component.inst.in diff --git a/source/multigrid/mg_dof_handler.cc b/source/multigrid/mg_dof_handler.cc deleted file mode 100644 index f6bb135386..0000000000 --- a/source/multigrid/mg_dof_handler.cc +++ /dev/null @@ -1,107 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 1998 - 2013 by the deal.II authors -// -// This file is part of the deal.II library. -// -// The deal.II library is free software; you can use it, redistribute -// it, and/or modify it under the terms of the GNU Lesser General -// Public License as published by the Free Software Foundation; either -// version 2.1 of the License, or (at your option) any later version. -// The full text of the license can be found in the file LICENSE at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - - -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include - -#include - -DEAL_II_NAMESPACE_OPEN - -namespace parallel -{ - namespace distributed - { - template class Triangulation; - } -} - - - -/* ------------------------ MGDoFHandler ------------------------------------- */ - -template -const unsigned int MGDoFHandler::dimension; - - -template -MGDoFHandler::MGDoFHandler () -{} - - - -template -MGDoFHandler::MGDoFHandler (const Triangulation &tria) - : - DoFHandler (tria) -{} - - -template -MGDoFHandler::~MGDoFHandler () -{} - -template -void MGDoFHandler::distribute_dofs (const FiniteElement &fe) -{ - // first distribute global dofs - DoFHandler::distribute_dofs (fe); - DoFHandler::distribute_mg_dofs (fe); -} - - - -template -typename MGDoFHandler::cell_iterator -MGDoFHandler::begin (const unsigned int level) const -{ - return DoFHandler::begin_mg(level); -} - - -template -typename MGDoFHandler::cell_iterator -MGDoFHandler::end (const unsigned int level) const -{ - return DoFHandler::end_mg(level); -} - - -template -typename MGDoFHandler::cell_iterator -MGDoFHandler::end () const -{ - return DoFHandler::end_mg(); -} - - -// explicit instantiations -#include "mg_dof_handler.inst" - - -DEAL_II_NAMESPACE_CLOSE diff --git a/source/multigrid/mg_dof_handler.inst.in b/source/multigrid/mg_dof_handler.inst.in deleted file mode 100644 index 1c5b7de658..0000000000 --- a/source/multigrid/mg_dof_handler.inst.in +++ /dev/null @@ -1,30 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 1998 - 2013 by the deal.II authors -// -// This file is part of the deal.II library. -// -// The deal.II library is free software; you can use it, redistribute -// it, and/or modify it under the terms of the GNU Lesser General -// Public License as published by the Free Software Foundation; either -// version 2.1 of the License, or (at your option) any later version. -// The full text of the license can be found in the file LICENSE at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - - - -for (deal_II_dimension : DIMENSIONS) - { -template class MGDoFHandler; - -#if deal_II_dimension==1 || deal_II_dimension==2 -template class MGDoFHandler; -#endif - -#if deal_II_dimension==3 -template class MGDoFHandler<1,3>; -#endif - } - diff --git a/source/multigrid/mg_tools.cc b/source/multigrid/mg_tools.cc index 544386c0dc..3f9c4cf560 100644 --- a/source/multigrid/mg_tools.cc +++ b/source/multigrid/mg_tools.cc @@ -25,7 +25,6 @@ #include #include #include -#include #include #include #include diff --git a/source/multigrid/mg_tools.inst.in b/source/multigrid/mg_tools.inst.in index 4dcf649f1b..398fd14824 100644 --- a/source/multigrid/mg_tools.inst.in +++ b/source/multigrid/mg_tools.inst.in @@ -27,12 +27,6 @@ for (PATTERN : SPARSITY_PATTERNS; deal_II_dimension : DIMENSIONS; const DoFHandler &, PATTERN &, const unsigned int); - - template void - make_sparsity_pattern, PATTERN> ( - const MGDoFHandler &, - PATTERN &, - const unsigned int); #endif #if deal_II_dimension == deal_II_space_dimension @@ -96,9 +90,6 @@ for (deal_II_dimension : DIMENSIONS) template void count_dofs_per_block ( const DoFHandler&, std::vector >&, std::vector); - template void count_dofs_per_block ( - const MGDoFHandler&, std::vector >&, - std::vector); #if deal_II_dimension > 1 template void make_boundary_list( diff --git a/source/multigrid/mg_transfer_block.cc b/source/multigrid/mg_transfer_block.cc index 2c54bcfbbb..ffb51138cd 100644 --- a/source/multigrid/mg_transfer_block.cc +++ b/source/multigrid/mg_transfer_block.cc @@ -24,7 +24,6 @@ #include #include #include -#include #include #include #include diff --git a/source/multigrid/mg_transfer_component.cc b/source/multigrid/mg_transfer_component.cc index 4a4d436f92..b3b62f2942 100644 --- a/source/multigrid/mg_transfer_component.cc +++ b/source/multigrid/mg_transfer_component.cc @@ -26,7 +26,6 @@ #include #include #include -#include #include #include #include diff --git a/source/multigrid/mg_transfer_prebuilt.cc b/source/multigrid/mg_transfer_prebuilt.cc index 3f5f67c8d3..5bb9ccc7cc 100644 --- a/source/multigrid/mg_transfer_prebuilt.cc +++ b/source/multigrid/mg_transfer_prebuilt.cc @@ -32,7 +32,6 @@ #include #include #include -#include #include #include #include diff --git a/source/numerics/fe_field_function.cc b/source/numerics/fe_field_function.cc index a428a29b44..d17b5ff5c6 100644 --- a/source/numerics/fe_field_function.cc +++ b/source/numerics/fe_field_function.cc @@ -15,7 +15,6 @@ #include -#include #include #include #include diff --git a/source/numerics/vector_tools_boundary.inst.in b/source/numerics/vector_tools_boundary.inst.in index c5375af1f0..b74e8e3c29 100644 --- a/source/numerics/vector_tools_boundary.inst.in +++ b/source/numerics/vector_tools_boundary.inst.in @@ -14,28 +14,6 @@ // --------------------------------------------------------------------- -for (deal_II_dimension : DIMENSIONS) -{ - namespace VectorTools \{ - template - void interpolate_boundary_values ( - const MGDoFHandler &, - const types::boundary_id, - const Function &, - ConstraintMatrix&, - const ComponentMask &); - - template - void interpolate_boundary_values ( - const MGDoFHandler &, - const types::boundary_id, - const Function &, - std::map &, - const ComponentMask &); - \} -} - - for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS; DH : DOFHANDLER_TEMPLATES) { #if deal_II_dimension <= deal_II_space_dimension diff --git a/tests/benchmarks/old/dof_handler_size.cc b/tests/benchmarks/old/dof_handler_size.cc index c9fade2363..dee3fd9a67 100644 --- a/tests/benchmarks/old/dof_handler_size.cc +++ b/tests/benchmarks/old/dof_handler_size.cc @@ -99,7 +99,7 @@ void check (bool local) check_dofs(dof); deallog.pop(); deallog.push("MGDoF"); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); check_dofs(mgdof); deallog.pop(); } diff --git a/tests/benchmarks/old/dof_handler_timing_01.cc b/tests/benchmarks/old/dof_handler_timing_01.cc index 2bb71adbdf..2dfada080e 100644 --- a/tests/benchmarks/old/dof_handler_timing_01.cc +++ b/tests/benchmarks/old/dof_handler_timing_01.cc @@ -85,7 +85,7 @@ void check (bool local) check_dofs(dof, (local ? 100 : 10)); deallog.pop(); deallog.push("MGDoF"); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); check_dofs(mgdof, (local ? 100 : 10)); deallog.pop(); } diff --git a/tests/benchmarks/old/patches/library/2007-05-30 b/tests/benchmarks/old/patches/library/2007-05-30 index cd619e8c49..ac5c4fec5a 100644 --- a/tests/benchmarks/old/patches/library/2007-05-30 +++ b/tests/benchmarks/old/patches/library/2007-05-30 @@ -27,14 +27,14 @@ Index: deal.II/source/multigrid/mg_dof_handler.cc +//TODO: This seems horrible memory fragmentation! template - MGDoFHandler::MGVertexDoFs::MGVertexDoFs () + DoFHandler::MGVertexDoFs::MGVertexDoFs () @@ -124,6 +125,25 @@ } +template +unsigned int -+MGDoFHandler::memory_consumption() const ++DoFHandler::memory_consumption() const +{ + unsigned int mem = DoFHandler::memory_consumption(); + for (unsigned int l=0;l #include #include -#include #include #include #include @@ -87,9 +86,9 @@ void check () // holds tria.refine_global (1); - MGDoFHandler dof_handler (tria); + DoFHandler dof_handler (tria); - for (typename MGDoFHandler::cell_iterator cell = dof_handler.begin(); + for (typename DoFHandler::cell_iterator cell = dof_handler.begin(); cell != dof_handler.end (); ++cell) for (unsigned int child = 0; child < cell->n_children (); ++child) Assert (cell->child (child)->parent () == cell, @@ -104,7 +103,7 @@ void check () tria.execute_coarsening_and_refinement (); - for (typename MGDoFHandler::cell_iterator cell = dof_handler.begin (); + for (typename DoFHandler::cell_iterator cell = dof_handler.begin (); cell != dof_handler.end(); ++cell) for (unsigned int child = 0; child < cell->n_children (); ++child) Assert (cell->child (child)->parent () == cell, diff --git a/tests/bits/step-16.cc b/tests/bits/step-16.cc index 273ac93cd8..c7dc654ac9 100644 --- a/tests/bits/step-16.cc +++ b/tests/bits/step-16.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2005 - 2013 by the deal.II authors +// Copyright (C) 2005 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -45,7 +45,6 @@ std::ofstream logfile("output"); #include #include #include -#include #include #include @@ -74,7 +73,7 @@ private: Triangulation triangulation; FE_Q fe; - MGDoFHandler mg_dof_handler; + DoFHandler mg_dof_handler; SparsityPattern sparsity_pattern; SparseMatrix system_matrix; @@ -99,6 +98,7 @@ template void LaplaceProblem::setup_system () { mg_dof_handler.distribute_dofs (fe); + mg_dof_handler.distribute_mg_dofs (fe); deallog << " Number of degrees of freedom: " << mg_dof_handler.n_dofs() @@ -204,7 +204,7 @@ void LaplaceProblem::assemble_multigrid () std::vector local_dof_indices (dofs_per_cell); - typename MGDoFHandler::cell_iterator cell = mg_dof_handler.begin(), + typename DoFHandler::cell_iterator cell = mg_dof_handler.begin(), endc = mg_dof_handler.end(); for (; cell!=endc; ++cell) { diff --git a/tests/bits/step-16b.cc b/tests/bits/step-16b.cc index 25ba59ddd7..374c750fe7 100644 --- a/tests/bits/step-16b.cc +++ b/tests/bits/step-16b.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2005 - 2014 by the deal.II authors +// Copyright (C) 2005 - 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -17,7 +17,7 @@ // a un-hp-ified version of hp/step-16 // this version uses the new unified DoFHAndler instead -// of the MGDoFHandler in the test step-16.cc +// of the DoFHandler in the test step-16.cc #include "../tests.h" @@ -47,7 +47,6 @@ std::ofstream logfile("output"); #include #include #include -#include #include #include @@ -207,7 +206,7 @@ void LaplaceProblem::assemble_multigrid () std::vector local_dof_indices (dofs_per_cell); - typename MGDoFHandler::cell_iterator cell = mg_dof_handler.begin(), + typename DoFHandler::cell_iterator cell = mg_dof_handler.begin(), endc = mg_dof_handler.end(); for (; cell!=endc; ++cell) { diff --git a/tests/deal.II/block_info.cc b/tests/deal.II/block_info.cc index 639b38837e..3a7245ba9d 100644 --- a/tests/deal.II/block_info.cc +++ b/tests/deal.II/block_info.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2009 - 2013 by the deal.II authors +// Copyright (C) 2009 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -16,7 +16,7 @@ #include "../tests.h" #include -#include +#include #include #include #include @@ -28,8 +28,9 @@ template void test_grid(const Triangulation &tr, const FiniteElement &fe) { - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); mgdof.distribute_dofs(fe); + mgdof.distribute_mg_dofs(fe); BlockInfo bi; bi.initialize(mgdof); bi.initialize_local(mgdof); diff --git a/tests/deal.II/block_info_02.cc b/tests/deal.II/block_info_02.cc index 55e1ecfc0e..d5ab507270 100644 --- a/tests/deal.II/block_info_02.cc +++ b/tests/deal.II/block_info_02.cc @@ -15,12 +15,11 @@ // same as block_info, but here we use the new DoFHandler instead -// of the MGDoFHandler +// of the DoFHandler #include "../tests.h" #include #include -#include #include #include #include diff --git a/tests/deal.II/block_list.h b/tests/deal.II/block_list.h index 37456d2bca..1010ed0158 100644 --- a/tests/deal.II/block_list.h +++ b/tests/deal.II/block_list.h @@ -16,7 +16,6 @@ #include "../tests.h" #include #include -#include #include #include #include diff --git a/tests/deal.II/block_list_01.cc b/tests/deal.II/block_list_01.cc index 621823966a..138bc516d0 100644 --- a/tests/deal.II/block_list_01.cc +++ b/tests/deal.II/block_list_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2009 - 2013 by the deal.II authors +// Copyright (C) 2009 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -22,9 +22,9 @@ test_block_list(const Triangulation &tr, const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - MGDoFHandler dof; + DoFHandler dof; dof.initialize(tr, fe); - + dof.distribute_mg_dofs (fe); const unsigned int level = tr.n_levels()-1; diff --git a/tests/deal.II/block_list_02.cc b/tests/deal.II/block_list_02.cc index 843111a7cb..1f12560ebe 100644 --- a/tests/deal.II/block_list_02.cc +++ b/tests/deal.II/block_list_02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2009 - 2013 by the deal.II authors +// Copyright (C) 2009 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -22,8 +22,9 @@ test_block_list(const Triangulation &tr, const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - MGDoFHandler dof; + DoFHandler dof; dof.initialize(tr, fe); + dof.distribute_mg_dofs (fe); const unsigned int level = tr.n_levels()-1; diff --git a/tests/deal.II/block_list_03.cc b/tests/deal.II/block_list_03.cc index 7f225268f5..0d3536392d 100644 --- a/tests/deal.II/block_list_03.cc +++ b/tests/deal.II/block_list_03.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2009 - 2013 by the deal.II authors +// Copyright (C) 2009 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -22,8 +22,9 @@ test_block_list(const Triangulation &tr, const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - MGDoFHandler dof; + DoFHandler dof; dof.initialize(tr, fe); + dof.distribute_mg_dofs (fe); const unsigned int level = tr.n_levels()-1; diff --git a/tests/deal.II/block_list_04.cc b/tests/deal.II/block_list_04.cc index 9eb7143048..ce2f91347b 100644 --- a/tests/deal.II/block_list_04.cc +++ b/tests/deal.II/block_list_04.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2009 - 2013 by the deal.II authors +// Copyright (C) 2009 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -22,8 +22,9 @@ test_block_list(const Triangulation &tr, const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - MGDoFHandler dof; + DoFHandler dof; dof.initialize(tr, fe); + dof.distribute_mg_dofs (fe); const unsigned int level = tr.n_levels()-1; diff --git a/tests/deal.II/dof_renumbering.cc b/tests/deal.II/dof_renumbering.cc index 706eff679c..d0008326be 100644 --- a/tests/deal.II/dof_renumbering.cc +++ b/tests/deal.II/dof_renumbering.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -29,7 +29,6 @@ #include #include #include -#include #include #include #include @@ -59,10 +58,10 @@ print_dofs (const DoFHandler &dof) template void -print_dofs (const MGDoFHandler &dof, unsigned int level) +print_dofs (const DoFHandler &dof, unsigned int level) { std::vector v (dof.get_fe().dofs_per_cell); - for (typename MGDoFHandler::cell_iterator cell=dof.begin(level); + for (typename DoFHandler::cell_iterator cell=dof.begin(level); cell != dof.end(level); ++cell) { deallog << "Cell " << cell << " -- "; @@ -76,7 +75,7 @@ print_dofs (const MGDoFHandler &dof, unsigned int level) template void -check_renumbering(MGDoFHandler &mgdof, bool discontinuous) +check_renumbering(DoFHandler &mgdof, bool discontinuous) { const FiniteElement &element = mgdof.get_fe(); DoFHandler &dof = mgdof; @@ -162,15 +161,17 @@ check () if (dim==1) tr.refine_global(2); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); FESystem e1 (FE_Q(2), 2, FE_DGQ(1), 1); mgdof.distribute_dofs(e1); + mgdof.distribute_mg_dofs(e1); check_renumbering(mgdof, false); mgdof.clear(); FESystem e2 (FE_DGP(2), 2, FE_DGQ(1), 1); mgdof.distribute_dofs(e2); + mgdof.distribute_mg_dofs(e2); check_renumbering(mgdof, true); mgdof.clear(); } diff --git a/tests/deal.II/dof_renumbering_02.cc b/tests/deal.II/dof_renumbering_02.cc index 8d3571581f..5c81630dde 100644 --- a/tests/deal.II/dof_renumbering_02.cc +++ b/tests/deal.II/dof_renumbering_02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -27,7 +27,6 @@ #include #include #include -#include #include #include #include @@ -73,7 +72,7 @@ print_dofs (const DoFHandler &dof) template void -print_dofs (const MGDoFHandler &dof, unsigned int level) +print_dofs (const DoFHandler &dof, unsigned int level) { const FiniteElement &fe = dof.get_fe(); std::vector v (fe.dofs_per_cell); @@ -85,7 +84,7 @@ print_dofs (const MGDoFHandler &dof, unsigned int level) fevalues = std_cxx11::shared_ptr >(new FEValues(fe, quad, update_q_points)); } - for (typename MGDoFHandler::cell_iterator cell=dof.begin(level); + for (typename DoFHandler::cell_iterator cell=dof.begin(level); cell != dof.end(level); ++cell) { Point p = cell->center(); @@ -105,7 +104,7 @@ print_dofs (const MGDoFHandler &dof, unsigned int level) template void -check_renumbering(MGDoFHandler &mgdof) +check_renumbering(DoFHandler &mgdof) { const FiniteElement &element = mgdof.get_fe(); DoFHandler &dof = mgdof; @@ -156,21 +155,24 @@ check () tr.execute_coarsening_and_refinement (); tr.refine_global(3-dim); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); FE_Q q2(2); FE_DGQ dgq1(1); FESystem system (q2, 2, dgq1, 1); mgdof.distribute_dofs(q2); + mgdof.distribute_mg_dofs(q2); check_renumbering(mgdof); mgdof.clear(); mgdof.distribute_dofs(dgq1); + mgdof.distribute_mg_dofs(dgq1); check_renumbering(mgdof); mgdof.clear(); mgdof.distribute_dofs(system); + mgdof.distribute_mg_dofs(system); check_renumbering(mgdof); mgdof.clear(); } diff --git a/tests/deal.II/dof_renumbering_03.cc b/tests/deal.II/dof_renumbering_03.cc index b1c0c7246d..fd6db726c7 100644 --- a/tests/deal.II/dof_renumbering_03.cc +++ b/tests/deal.II/dof_renumbering_03.cc @@ -27,7 +27,6 @@ #include #include #include -#include #include #include #include diff --git a/tests/deal.II/dof_renumbering_04.cc b/tests/deal.II/dof_renumbering_04.cc index 3fa76b3dc6..3039be2b08 100644 --- a/tests/deal.II/dof_renumbering_04.cc +++ b/tests/deal.II/dof_renumbering_04.cc @@ -27,7 +27,6 @@ #include #include #include -#include #include #include #include diff --git a/tests/deal.II/dof_renumbering_04a.cc b/tests/deal.II/dof_renumbering_04a.cc index 34cb093fbe..d57a0006a2 100644 --- a/tests/deal.II/dof_renumbering_04a.cc +++ b/tests/deal.II/dof_renumbering_04a.cc @@ -28,7 +28,6 @@ #include #include #include -#include #include #include #include diff --git a/tests/deal.II/dof_renumbering_05.cc b/tests/deal.II/dof_renumbering_05.cc index b6cc9f2ec2..79433f1b05 100644 --- a/tests/deal.II/dof_renumbering_05.cc +++ b/tests/deal.II/dof_renumbering_05.cc @@ -27,7 +27,6 @@ #include #include #include -#include #include #include #include diff --git a/tests/deal.II/dof_renumbering_06.cc b/tests/deal.II/dof_renumbering_06.cc index 820ecef6ad..bfd337bf9c 100644 --- a/tests/deal.II/dof_renumbering_06.cc +++ b/tests/deal.II/dof_renumbering_06.cc @@ -27,7 +27,6 @@ #include #include #include -#include #include #include #include diff --git a/tests/deal.II/extract_dofs_by_component_02_mg.cc b/tests/deal.II/extract_dofs_by_component_02_mg.cc index 226df7cb9d..64e8f75c0f 100644 --- a/tests/deal.II/extract_dofs_by_component_02_mg.cc +++ b/tests/deal.II/extract_dofs_by_component_02_mg.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -35,7 +35,6 @@ #include #include #include -#include #include @@ -54,8 +53,9 @@ check () FESystem element (FE_Q(2), 1, FE_Nedelec(0), 1); - MGDoFHandler dof(tr); + DoFHandler dof(tr); dof.distribute_dofs(element); + dof.distribute_mg_dofs(element); // try all possible block // masks, which we encode as bit diff --git a/tests/deal.II/get_finest_common_cells_01.cc b/tests/deal.II/get_finest_common_cells_01.cc index 7b304327ca..30ced5239f 100644 --- a/tests/deal.II/get_finest_common_cells_01.cc +++ b/tests/deal.II/get_finest_common_cells_01.cc @@ -21,7 +21,6 @@ #include #include #include -#include #include #include diff --git a/tests/deal.II/get_finest_common_cells_02.cc b/tests/deal.II/get_finest_common_cells_02.cc index 11806def82..96d6de0f8f 100644 --- a/tests/deal.II/get_finest_common_cells_02.cc +++ b/tests/deal.II/get_finest_common_cells_02.cc @@ -21,7 +21,6 @@ #include #include #include -#include #include #include diff --git a/tests/deal.II/get_finest_common_cells_03.cc b/tests/deal.II/get_finest_common_cells_03.cc index c1b5c6097c..d1f04a0193 100644 --- a/tests/deal.II/get_finest_common_cells_03.cc +++ b/tests/deal.II/get_finest_common_cells_03.cc @@ -21,7 +21,6 @@ #include #include #include -#include #include #include diff --git a/tests/deal.II/get_finest_common_cells_04.cc b/tests/deal.II/get_finest_common_cells_04.cc index 0e8c7abd68..96d6de0f8f 100644 --- a/tests/deal.II/get_finest_common_cells_04.cc +++ b/tests/deal.II/get_finest_common_cells_04.cc @@ -21,7 +21,6 @@ #include #include #include -#include #include #include @@ -50,12 +49,12 @@ void test() tria[1].last_active()->set_refine_flag(); tria[1].execute_coarsening_and_refinement (); - MGDoFHandler dh0 (tria[0]); - MGDoFHandler dh1 (tria[1]); + DoFHandler dh0 (tria[0]); + DoFHandler dh1 (tria[1]); typedef - std::list::cell_iterator, - typename MGDoFHandler::cell_iterator> > + std::list::cell_iterator, + typename DoFHandler::cell_iterator> > CellList; const CellList cell_list diff --git a/tests/deal.II/have_same_coarse_mesh_01.cc b/tests/deal.II/have_same_coarse_mesh_01.cc index 72d5b06b59..1cd43fa124 100644 --- a/tests/deal.II/have_same_coarse_mesh_01.cc +++ b/tests/deal.II/have_same_coarse_mesh_01.cc @@ -21,7 +21,6 @@ #include #include #include -#include #include diff --git a/tests/deal.II/have_same_coarse_mesh_02.cc b/tests/deal.II/have_same_coarse_mesh_02.cc index a7d867316d..f9dbb1369b 100644 --- a/tests/deal.II/have_same_coarse_mesh_02.cc +++ b/tests/deal.II/have_same_coarse_mesh_02.cc @@ -21,7 +21,6 @@ #include #include #include -#include #include diff --git a/tests/deal.II/have_same_coarse_mesh_03.cc b/tests/deal.II/have_same_coarse_mesh_03.cc index 15956eb1f0..ab3f1551c6 100644 --- a/tests/deal.II/have_same_coarse_mesh_03.cc +++ b/tests/deal.II/have_same_coarse_mesh_03.cc @@ -21,7 +21,6 @@ #include #include #include -#include #include diff --git a/tests/deal.II/have_same_coarse_mesh_04.cc b/tests/deal.II/have_same_coarse_mesh_04.cc index 892eaa8ee3..f9dbb1369b 100644 --- a/tests/deal.II/have_same_coarse_mesh_04.cc +++ b/tests/deal.II/have_same_coarse_mesh_04.cc @@ -21,7 +21,6 @@ #include #include #include -#include #include @@ -49,11 +48,11 @@ void test() tria[2].refine_global (3); - MGDoFHandler dh0 (tria[0]); - MGDoFHandler dh1 (tria[1]); - MGDoFHandler dh2 (tria[2]); + DoFHandler dh0 (tria[0]); + DoFHandler dh1 (tria[1]); + DoFHandler dh2 (tria[2]); - MGDoFHandler *dof_handler[3] = { &dh0, &dh1, &dh2 }; + DoFHandler *dof_handler[3] = { &dh0, &dh1, &dh2 }; for (unsigned int i=0; i<3; ++i) for (unsigned int j=0; j<3; ++j) diff --git a/tests/deal.II/helmholtz.h b/tests/deal.II/helmholtz.h index 7fb81968ac..d35cf8b080 100644 --- a/tests/deal.II/helmholtz.h +++ b/tests/deal.II/helmholtz.h @@ -17,7 +17,7 @@ public: template void build_mgmatrix(MGLevelObject &A, - const MGDoFHandler &dof, + const DoFHandler &dof, const Quadrature &quadrature); }; diff --git a/tests/deal.II/helmholtz1mg.th b/tests/deal.II/helmholtz1mg.th index 995b23bedb..de421c71aa 100644 --- a/tests/deal.II/helmholtz1mg.th +++ b/tests/deal.II/helmholtz1mg.th @@ -2,7 +2,7 @@ template void Helmholtz::build_mgmatrix(MGLevelObject& A, - const MGDoFHandler& dof, + const DoFHandler& dof, const Quadrature& quadrature) { const unsigned int fe_dofs = dof.get_fe().n_dofs_per_cell(); @@ -19,7 +19,7 @@ Helmholtz::build_mgmatrix(MGLevelObject& A, //////////////////////////////////////////////////// DoFHandler::cell_iterator dc = dof.DoFHandler::begin(); - for (MGDoFHandler::cell_iterator c = dof.begin() + for (DoFHandler::cell_iterator c = dof.begin() ; c != dof.end() ; ++c, ++dc) { elmat.clear(); diff --git a/tests/deal.II/mg_dof_handler.cc b/tests/deal.II/mg_dof_handler.cc index d7b567448b..6a7b556fd0 100644 --- a/tests/deal.II/mg_dof_handler.cc +++ b/tests/deal.II/mg_dof_handler.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2005 - 2013 by the deal.II authors +// Copyright (C) 2005 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -15,7 +15,7 @@ -/* Author: Ralf Hartmann, 2005; the MGDoFHandler class had troubles +/* Author: Ralf Hartmann, 2005; the DoFHandler class had troubles when the triangulation had unused vertices before, make sure that this is now fixed. */ @@ -26,7 +26,7 @@ #include #include #include -#include +#include #include @@ -45,7 +45,7 @@ int main () GridGenerator::hyper_cube(tria); FE_DGQ fe(1); - MGDoFHandler dof_handler(tria); + DoFHandler dof_handler(tria); tria.begin_active()->set_refine_flag(); tria.execute_coarsening_and_refinement(); diff --git a/tests/fe/transfer.cc b/tests/fe/transfer.cc index 15ea92699d..81f0443dc7 100644 --- a/tests/fe/transfer.cc +++ b/tests/fe/transfer.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 1998 - 2013 by the deal.II authors +// Copyright (C) 1998 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -28,7 +28,6 @@ #include #include #include -#include #include #include @@ -46,8 +45,9 @@ print_matrix(Triangulation &tr, const FiniteElement &finel, const char * /*name*/) { - MGDoFHandler dof(tr); + DoFHandler dof(tr); dof.distribute_dofs(finel); + dof.distribute_mg_dofs(finel); MGTransferPrebuilt > transfer; transfer.build_matrices(dof); diff --git a/tests/hp/dof_renumbering_04.cc b/tests/hp/dof_renumbering_04.cc index c3fdd277f0..c0ab3152dd 100644 --- a/tests/hp/dof_renumbering_04.cc +++ b/tests/hp/dof_renumbering_04.cc @@ -27,7 +27,6 @@ #include #include #include -#include #include #include #include diff --git a/tests/hp/dof_renumbering_05.cc b/tests/hp/dof_renumbering_05.cc index e479005532..dc531ebc79 100644 --- a/tests/hp/dof_renumbering_05.cc +++ b/tests/hp/dof_renumbering_05.cc @@ -27,7 +27,6 @@ #include #include #include -#include #include #include #include diff --git a/tests/hp/dof_renumbering_06.cc b/tests/hp/dof_renumbering_06.cc index 5d70911d0c..1d7bbcb07b 100644 --- a/tests/hp/dof_renumbering_06.cc +++ b/tests/hp/dof_renumbering_06.cc @@ -27,7 +27,6 @@ #include #include #include -#include #include #include #include diff --git a/tests/hp/renumber_block_wise_01.cc b/tests/hp/renumber_block_wise_01.cc index 46eaab918c..7ecedd10a8 100644 --- a/tests/hp/renumber_block_wise_01.cc +++ b/tests/hp/renumber_block_wise_01.cc @@ -31,7 +31,6 @@ #include #include #include -#include #include #include #include diff --git a/tests/hp/renumber_block_wise_01a.cc b/tests/hp/renumber_block_wise_01a.cc index 4da4817f0d..e3e3bee695 100644 --- a/tests/hp/renumber_block_wise_01a.cc +++ b/tests/hp/renumber_block_wise_01a.cc @@ -30,7 +30,6 @@ #include #include #include -#include #include #include #include diff --git a/tests/hp/renumber_block_wise_01b.cc b/tests/hp/renumber_block_wise_01b.cc index 48ab59fadc..2c551b471d 100644 --- a/tests/hp/renumber_block_wise_01b.cc +++ b/tests/hp/renumber_block_wise_01b.cc @@ -34,7 +34,6 @@ #include #include #include -#include #include #include #include diff --git a/tests/hp/renumber_block_wise_02.cc b/tests/hp/renumber_block_wise_02.cc index c11c07ee20..1da457acfd 100644 --- a/tests/hp/renumber_block_wise_02.cc +++ b/tests/hp/renumber_block_wise_02.cc @@ -31,7 +31,6 @@ #include #include #include -#include #include #include #include diff --git a/tests/hp/renumber_component_wise.cc b/tests/hp/renumber_component_wise.cc index aae2f037e1..38deafd83b 100644 --- a/tests/hp/renumber_component_wise.cc +++ b/tests/hp/renumber_component_wise.cc @@ -29,7 +29,6 @@ #include #include #include -#include #include #include #include diff --git a/tests/integrators/assembler_simple_mgmatrix_03.cc b/tests/integrators/assembler_simple_mgmatrix_03.cc index a2d9d246a3..ce02b28f5a 100644 --- a/tests/integrators/assembler_simple_mgmatrix_03.cc +++ b/tests/integrators/assembler_simple_mgmatrix_03.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2012 - 2013 by the deal.II authors +// Copyright (C) 2012 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -26,7 +26,6 @@ #include #include #include -#include #include #include #include @@ -67,16 +66,18 @@ void test(FiniteElement &fe) GridGenerator::hyper_cube(tr); tr.refine_global(1); - MGDoFHandler dof(tr); + DoFHandler dof(tr); dof.distribute_dofs(fe); + dof.distribute_mg_dofs(fe); dof.initialize_local_block_info(); - DoFRenumbering::component_wise(dof); + for (unsigned int level=0; level::cell_iterator cell = dof.begin_active(); - typename MGDoFHandler::face_iterator face = cell->face(1); - typename MGDoFHandler::cell_iterator neighbor = cell->neighbor(1); + typename DoFHandler::level_cell_iterator cell = dof.begin_active(); + typename DoFHandler::face_iterator face = cell->face(1); + typename DoFHandler::level_cell_iterator neighbor = cell->neighbor(1); MGLevelObject sparsity(0, tr.n_levels()-1); MGLevelObject > matrix(0, tr.n_levels()-1); diff --git a/tests/integrators/assembler_simple_mgmatrix_04.cc b/tests/integrators/assembler_simple_mgmatrix_04.cc index c84a6ebf86..a6110da855 100644 --- a/tests/integrators/assembler_simple_mgmatrix_04.cc +++ b/tests/integrators/assembler_simple_mgmatrix_04.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2012 - 2013 by the deal.II authors +// Copyright (C) 2012 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -158,8 +158,9 @@ void test(FiniteElement &fe) LaplaceMatrix matrix_integrator; - MGDoFHandler dof(tr); + DoFHandler dof(tr); dof.distribute_dofs(fe); + dof.distribute_mg_dofs(fe); mg::SparseMatrixCollection mg; mg.resize(0,tr.n_levels()-1); mg.reinit(dof); diff --git a/tests/integrators/cells_and_faces_01.cc b/tests/integrators/cells_and_faces_01.cc index 96e654f4f6..4c4199e6dc 100644 --- a/tests/integrators/cells_and_faces_01.cc +++ b/tests/integrators/cells_and_faces_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -85,7 +85,7 @@ Local::face(MeshWorker::DoFInfo &info1, MeshWorker::DoFInfo &inf template void -test_mesh(MGDoFHandler &mgdofs) +test_mesh(DoFHandler &mgdofs) { const DoFHandler &dofs = mgdofs; @@ -139,7 +139,7 @@ test_mesh(MGDoFHandler &mgdofs) MeshWorker::DoFInfo mg_dof_info(mgdofs); MeshWorker::loop, EmptyInfoBox> - (mgdofs.begin(), mgdofs.end(), + (mgdofs.begin_mg(), mgdofs.end_mg(), mg_dof_info, info_box, std_cxx11::bind (&Local::cell, local, std_cxx11::_1, std_cxx11::_2), std_cxx11::bind (&Local::bdry, local, std_cxx11::_1, std_cxx11::_2), @@ -163,23 +163,26 @@ void test(const FiniteElement &fe) { Triangulation tr; - MGDoFHandler dofs(tr); + DoFHandler dofs(tr); GridGenerator::hyper_cube(tr); tr.refine_global(1); deallog.push("1"); dofs.distribute_dofs(fe); + dofs.distribute_mg_dofs(fe); test_mesh(dofs); deallog.pop(); tr.begin(1)->set_refine_flag(); tr.execute_coarsening_and_refinement(); deallog.push("2"); dofs.distribute_dofs(fe); + dofs.distribute_mg_dofs(fe); test_mesh(dofs); deallog.pop(); tr.begin(2)->set_refine_flag(); tr.execute_coarsening_and_refinement(); deallog.push("3"); dofs.distribute_dofs(fe); + dofs.distribute_mg_dofs(fe); test_mesh(dofs); deallog.pop(); } diff --git a/tests/integrators/functional_01.cc b/tests/integrators/functional_01.cc index 2f6be91ba3..dc5bccfaac 100644 --- a/tests/integrators/functional_01.cc +++ b/tests/integrators/functional_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -84,7 +84,7 @@ Local::face(MeshWorker::DoFInfo &info1, MeshWorker::DoFInfo &inf template void -test_mesh(MGDoFHandler &mgdofs) +test_mesh(DoFHandler &mgdofs) { const DoFHandler &dofs = mgdofs; @@ -115,7 +115,7 @@ test_mesh(MGDoFHandler &mgdofs) assembler.initialize(n_functionals); MeshWorker::DoFInfo mg_dof_info(mgdofs); MeshWorker::loop, EmptyInfoBox> - (mgdofs.begin(), mgdofs.end(), + (mgdofs.begin_mg(), mgdofs.end_mg(), mg_dof_info, info_box, std_cxx11::bind (&Local::cell, local, std_cxx11::_1, std_cxx11::_2), std_cxx11::bind (&Local::bdry, local, std_cxx11::_1, std_cxx11::_2), @@ -134,23 +134,26 @@ void test(const FiniteElement &fe) { Triangulation tr; - MGDoFHandler dofs(tr); + DoFHandler dofs(tr); GridGenerator::hyper_cube(tr); tr.refine_global(1); deallog.push("1"); dofs.distribute_dofs(fe); + dofs.distribute_mg_dofs(fe); test_mesh(dofs); deallog.pop(); tr.begin(1)->set_refine_flag(); tr.execute_coarsening_and_refinement(); deallog.push("2"); dofs.distribute_dofs(fe); + dofs.distribute_mg_dofs(fe); test_mesh(dofs); deallog.pop(); tr.begin(2)->set_refine_flag(); tr.execute_coarsening_and_refinement(); deallog.push("3"); dofs.distribute_dofs(fe); + dofs.distribute_mg_dofs(fe); test_mesh(dofs); deallog.pop(); } diff --git a/tests/integrators/mesh_worker_01.cc b/tests/integrators/mesh_worker_01.cc index bc3504acc1..bc2ff3b64c 100644 --- a/tests/integrators/mesh_worker_01.cc +++ b/tests/integrators/mesh_worker_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -112,7 +112,7 @@ Local::face(MeshWorker::DoFInfo & , MeshWorker::DoFInfo &, template void -test_simple(MGDoFHandler &mgdofs) +test_simple(DoFHandler &mgdofs) { SparsityPattern pattern; SparseMatrix matrix; @@ -187,8 +187,9 @@ test(const FiniteElement &fe) cell != tr.end(); ++cell, ++cn) cell->set_user_index(cn); - MGDoFHandler dofs(tr); + DoFHandler dofs(tr); dofs.distribute_dofs(fe); + dofs.distribute_mg_dofs(fe); deallog << "DoFHandler " << dofs.n_dofs() << " levels"; for (unsigned int l=0; l &dof_handler, SparseMatrix &matrix) template void -assemble(const MGDoFHandler &dof_handler, +assemble(const DoFHandler &dof_handler, MGLevelObject > matrix, MGLevelObject > dg_up, MGLevelObject > dg_down) @@ -199,7 +199,7 @@ assemble(const MGDoFHandler &dof_handler, template void -test_simple(MGDoFHandler &mgdofs) +test_simple(DoFHandler &mgdofs) { SparsityPattern pattern; SparseMatrix matrix; @@ -278,8 +278,9 @@ test(const FiniteElement &fe) cell != tr.end(); ++cell, ++cn) cell->set_user_index(cn); - MGDoFHandler dofs(tr); + DoFHandler dofs(tr); dofs.distribute_dofs(fe); + dofs.distribute_mg_dofs(fe); deallog << "DoFHandler " << dofs.n_dofs() << " levels"; for (unsigned int l=0; l &dof_handler, SparseMatrix &matrix) template void -assemble(const MGDoFHandler &dof_handler, +assemble(const DoFHandler &dof_handler, MGLevelObject > matrix, MGLevelObject > dg_up, MGLevelObject > dg_down) @@ -212,7 +212,7 @@ assemble(const MGDoFHandler &dof_handler, template void -test_simple(MGDoFHandler &mgdofs) +test_simple(DoFHandler &mgdofs) { SparsityPattern pattern; SparseMatrix matrix; @@ -292,8 +292,9 @@ test(const FiniteElement &fe) cell != tr.end(); ++cell, ++cn) cell->set_user_index(cn); - MGDoFHandler dofs(tr); + DoFHandler dofs(tr); dofs.distribute_dofs(fe); + dofs.distribute_mg_dofs(fe); deallog << "DoFHandler " << dofs.n_dofs() << " levels"; for (unsigned int l=0; l #include #include -#include #include #include diff --git a/tests/mpi/mesh_worker_03.cc b/tests/mpi/mesh_worker_03.cc index 3c739c5f01..ed41741006 100644 --- a/tests/mpi/mesh_worker_03.cc +++ b/tests/mpi/mesh_worker_03.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // diff --git a/tests/mpi/multigrid_adaptive.cc b/tests/mpi/multigrid_adaptive.cc index 8a85487ab5..35dc720d69 100644 --- a/tests/mpi/multigrid_adaptive.cc +++ b/tests/mpi/multigrid_adaptive.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2008 - 2013 by the deal.II authors +// Copyright (C) 2008 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -55,7 +55,6 @@ #include #include -#include #include #include #include diff --git a/tests/mpi/multigrid_uniform.cc b/tests/mpi/multigrid_uniform.cc index dc91a90fb2..92704986ae 100644 --- a/tests/mpi/multigrid_uniform.cc +++ b/tests/mpi/multigrid_uniform.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2008 - 2013 by the deal.II authors +// Copyright (C) 2008 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -55,7 +55,6 @@ #include #include -#include #include #include #include diff --git a/tests/mpi/step-39.cc b/tests/mpi/step-39.cc index f1374e30de..ad2b3e5603 100644 --- a/tests/mpi/step-39.cc +++ b/tests/mpi/step-39.cc @@ -35,7 +35,6 @@ #include #include #include -#include #include #include diff --git a/tests/mpi/torus.cc b/tests/mpi/torus.cc index 50f2e5f453..4449e97dcd 100644 --- a/tests/mpi/torus.cc +++ b/tests/mpi/torus.cc @@ -35,7 +35,6 @@ #include #include #include -#include #include #include diff --git a/tests/multigrid/boundary_01.cc b/tests/multigrid/boundary_01.cc index 85704a631f..d1335b1862 100644 --- a/tests/multigrid/boundary_01.cc +++ b/tests/multigrid/boundary_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2006 - 2013 by the deal.II authors +// Copyright (C) 2006 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -31,7 +31,6 @@ #include #include #include -#include #include #include @@ -66,8 +65,9 @@ void check_fe(FiniteElement &fe) typename FunctionMap::type fmap; fmap.insert(std::make_pair(0, &zero)); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); mgdof.distribute_dofs(fe); + mgdof.distribute_mg_dofs(fe); std::vector > boundary_indices(tr.n_levels()); MGTools::make_boundary_list(mgdof, fmap, boundary_indices); diff --git a/tests/multigrid/count_01.cc b/tests/multigrid/count_01.cc index a213230b32..2ba3ebb15a 100644 --- a/tests/multigrid/count_01.cc +++ b/tests/multigrid/count_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2006 - 2013 by the deal.II authors +// Copyright (C) 2006 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -28,7 +28,6 @@ #include #include #include -#include #include #include @@ -61,8 +60,9 @@ void check_fe(FiniteElement &fe) tr.execute_coarsening_and_refinement (); tr.refine_global(1); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); mgdof.distribute_dofs(fe); + mgdof.distribute_mg_dofs(fe); std::vector > count(tr.n_levels()); MGTools::count_dofs_per_component(mgdof, count, false); diff --git a/tests/multigrid/dof_01.cc b/tests/multigrid/dof_01.cc index 229b7a3aa1..de463a8967 100644 --- a/tests/multigrid/dof_01.cc +++ b/tests/multigrid/dof_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2006 - 2013 by the deal.II authors +// Copyright (C) 2006 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -31,7 +31,6 @@ #include #include #include -#include #include #include @@ -43,10 +42,10 @@ using namespace std; template -void dofs(const MGDoFHandler &dof) +void dofs(const DoFHandler &dof) { - typename MGDoFHandler::cell_iterator cell; - const typename MGDoFHandler::cell_iterator end = dof.end(); + typename DoFHandler::cell_iterator cell; + const typename DoFHandler::cell_iterator end = dof.end(); std::vector indices; @@ -78,8 +77,9 @@ void check_fe(FiniteElement &fe) typename FunctionMap::type fmap; fmap.insert(std::make_pair(0, &zero)); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); mgdof.distribute_dofs(fe); + mgdof.distribute_mg_dofs(fe); dofs(mgdof); } diff --git a/tests/multigrid/dof_02.cc b/tests/multigrid/dof_02.cc index 62c83319e0..fdb0091a76 100644 --- a/tests/multigrid/dof_02.cc +++ b/tests/multigrid/dof_02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2006 - 2013 by the deal.II authors +// Copyright (C) 2006 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -31,7 +31,6 @@ #include #include #include -#include #include #include @@ -43,10 +42,10 @@ using namespace std; template -void dofs(const MGDoFHandler &dof) +void dofs(const DoFHandler &dof) { - typename MGDoFHandler::cell_iterator cell; - const typename MGDoFHandler::cell_iterator end = dof.end(); + typename DoFHandler::cell_iterator cell; + const typename DoFHandler::cell_iterator end = dof.end(); std::vector indices; @@ -57,7 +56,7 @@ void dofs(const MGDoFHandler &dof) deallog << "Level " << cell->level() << std::endl; for (unsigned int f=0; f::faces_per_cell; ++f) { - typename MGDoFHandler::face_iterator face = cell->face(f); + typename DoFHandler::face_iterator face = cell->face(f); face->get_mg_dof_indices(cell->level(), indices); for (unsigned int i=0; i::vertices_per_face; ++i) @@ -83,8 +82,9 @@ void check_fe(FiniteElement &fe) typename FunctionMap::type fmap; fmap.insert(std::make_pair(0, &zero)); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); mgdof.distribute_dofs(fe); + mgdof.distribute_mg_dofs(fe); dofs(mgdof); } diff --git a/tests/multigrid/dof_03.cc b/tests/multigrid/dof_03.cc index bb21bc007d..19f4e03507 100644 --- a/tests/multigrid/dof_03.cc +++ b/tests/multigrid/dof_03.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2006 - 2014 by the deal.II authors +// Copyright (C) 2006 - 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -22,8 +22,8 @@ #include #include #include +#include #include -#include #include #include @@ -57,6 +57,7 @@ void check() << std::endl; + dof.distribute_dofs(fe); dof.distribute_mg_dofs(fe); deallog << "check " << dim << " level distribute " << dof.has_active_dofs() << ' ' diff --git a/tests/multigrid/mg_renumbered_01.cc b/tests/multigrid/mg_renumbered_01.cc index d40d305e9c..cecbf5d129 100644 --- a/tests/multigrid/mg_renumbered_01.cc +++ b/tests/multigrid/mg_renumbered_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2010 - 2013 by the deal.II authors +// Copyright (C) 2010 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -49,7 +49,6 @@ #include #include -#include #include #include #include @@ -65,7 +64,7 @@ using namespace dealii; template void -reinit_vector (const dealii::MGDoFHandler &mg_dof, +reinit_vector (const dealii::DoFHandler &mg_dof, MGLevelObject > &v) { for (unsigned int level=v.min_level(); @@ -77,13 +76,13 @@ reinit_vector (const dealii::MGDoFHandler &mg_dof, } template -void initialize (const MGDoFHandler &dof, +void initialize (const DoFHandler &dof, Vector &u) { unsigned int counter=0; const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; std::vector dof_indices(dofs_per_cell); - for (typename MGDoFHandler::active_cell_iterator + for (typename DoFHandler::active_cell_iterator cell = dof.begin_active(); cell != dof.end(); ++cell) { @@ -96,13 +95,13 @@ void initialize (const MGDoFHandler &dof, template -void initialize (const MGDoFHandler &dof, +void initialize (const DoFHandler &dof, MGLevelObject > &u) { unsigned int counter=0; const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; std::vector dof_indices(dofs_per_cell); - typename MGDoFHandler::cell_iterator + typename DoFHandler::cell_iterator cell = dof.begin(0); cell->get_mg_dof_indices(dof_indices); for (unsigned int i=0; i &dof, template -void print_diff (const MGDoFHandler &dof_1, const MGDoFHandler &dof_2, +void print_diff (const DoFHandler &dof_1, const DoFHandler &dof_2, const Vector &u, const Vector &v) { Vector diff; @@ -119,7 +118,7 @@ void print_diff (const MGDoFHandler &dof_1, const MGDoFHandler &dof_2, const unsigned int dofs_per_cell = dof_1.get_fe().dofs_per_cell; std::vector dof_indices_1(dofs_per_cell); std::vector dof_indices_2(dofs_per_cell); - for (typename MGDoFHandler::active_cell_iterator + for (typename DoFHandler::active_cell_iterator cell_1 = dof_1.begin_active(), cell_2 = dof_2.begin_active(); cell_1 != dof_1.end(); ++cell_1, ++cell_2) { @@ -133,7 +132,7 @@ void print_diff (const MGDoFHandler &dof_1, const MGDoFHandler &dof_2, } template -void print(const MGDoFHandler &dof, std::vector > &interface_dofs) +void print(const DoFHandler &dof, std::vector > &interface_dofs) { const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; std::vector dof_indices(dofs_per_cell); @@ -141,7 +140,7 @@ void print(const MGDoFHandler &dof, std::vector > &interf { deallog << std::endl; deallog << "Level " << l << std::endl; - for (typename MGDoFHandler::cell_iterator + for (typename DoFHandler::cell_iterator cell = dof.begin(l); cell != dof.end(l); ++cell) { @@ -169,8 +168,8 @@ private: Triangulation triangulation; FESystem fe; - MGDoFHandler mg_dof_handler; - MGDoFHandler mg_dof_handler_renumbered; + DoFHandler mg_dof_handler; + DoFHandler mg_dof_handler_renumbered; MGLevelObject mg_sparsity_renumbered; MGLevelObject > mg_matrices_renumbered; @@ -200,8 +199,10 @@ LaplaceProblem::LaplaceProblem (const unsigned int deg) : template void LaplaceProblem::setup_system () { - mg_dof_handler.distribute_dofs (fe); + mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs (fe); mg_dof_handler_renumbered.distribute_dofs (fe); + mg_dof_handler_renumbered.distribute_mg_dofs (fe); std::vector block_component (2*dim,0); for (unsigned int c=dim; c<2*dim; ++c) @@ -300,7 +301,7 @@ void LaplaceProblem::test_renumber () const unsigned int dofs_per_cell = mg_dof_handler_renumbered.get_fe().dofs_per_cell; std::vector dof_indices(dofs_per_cell); - for (typename MGDoFHandler::cell_iterator + for (typename DoFHandler::cell_iterator cell = mg_dof_handler_renumbered.begin(); cell != mg_dof_handler_renumbered.end(); ++cell) { diff --git a/tests/multigrid/mg_renumbered_02.cc b/tests/multigrid/mg_renumbered_02.cc index d35e88a4aa..21c484caf8 100644 --- a/tests/multigrid/mg_renumbered_02.cc +++ b/tests/multigrid/mg_renumbered_02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2013 by the deal.II authors +// Copyright (C) 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -51,7 +51,6 @@ #include #include -#include #include #include #include @@ -68,7 +67,7 @@ using namespace dealii; template void -reinit_vector (const dealii::MGDoFHandler &mg_dof, +reinit_vector (const dealii::DoFHandler &mg_dof, MGLevelObject > &v) { for (unsigned int level=v.min_level(); @@ -80,12 +79,12 @@ reinit_vector (const dealii::MGDoFHandler &mg_dof, } template -void initialize (const MGDoFHandler &dof, +void initialize (const DoFHandler &dof, Vector &u) { const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; std::vector dof_indices(dofs_per_cell); - for (typename MGDoFHandler::active_cell_iterator + for (typename DoFHandler::active_cell_iterator cell = dof.begin_active(); cell != dof.end(); ++cell) { @@ -100,13 +99,13 @@ void initialize (const MGDoFHandler &dof, template -void initialize (const MGDoFHandler &dof, +void initialize (const DoFHandler &dof, MGLevelObject > &u) { unsigned int counter=0; const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; std::vector dof_indices(dofs_per_cell); - typename MGDoFHandler::cell_iterator + typename DoFHandler::cell_iterator cell = dof.begin(0); cell->get_mg_dof_indices(dof_indices); for (unsigned int i=0; i &dof, template -void diff (Vector &diff, const MGDoFHandler &dof, +void diff (Vector &diff, const DoFHandler &dof, const Vector &v, const unsigned int level) { diff.reinit (v); const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; std::vector mg_dof_indices(dofs_per_cell); const unsigned int n_comp = dof.get_fe().n_components(); - for (typename MGDoFHandler::cell_iterator + for (typename DoFHandler::cell_iterator cell= dof.begin(level); cell != dof.end(level); ++cell) { @@ -184,14 +183,14 @@ public: private: void setup_system (); void test_boundary (); - void output_gpl(const MGDoFHandler &dof, + void output_gpl(const DoFHandler &dof, MGLevelObject > &v); void refine_local (); Triangulation triangulation; const MappingQ1 mapping; FESystem fe; - MGDoFHandler mg_dof_handler_renumbered; + DoFHandler mg_dof_handler_renumbered; const unsigned int degree; std::vector > @@ -213,6 +212,7 @@ template void LaplaceProblem::setup_system () { mg_dof_handler_renumbered.distribute_dofs (fe); + mg_dof_handler_renumbered.distribute_mg_dofs (fe); const unsigned int nlevels = triangulation.n_levels(); @@ -236,7 +236,7 @@ void LaplaceProblem::setup_system () template void -LaplaceProblem::output_gpl(const MGDoFHandler &dof, +LaplaceProblem::output_gpl(const DoFHandler &dof, MGLevelObject > &v) { MeshWorker::IntegrationInfoBox info_box; @@ -262,7 +262,7 @@ LaplaceProblem::output_gpl(const MGDoFHandler &dof, { OutputCreator matrix_integrator; MeshWorker::loop, MeshWorker::IntegrationInfoBox > ( - dof.begin(l), dof.end(l), + dof.begin_mg(l), dof.end_mg(l), dof_info, info_box, std_cxx11::bind(&OutputCreator::cell, &matrix_integrator, std_cxx11::_1, std_cxx11::_2), 0, diff --git a/tests/multigrid/mg_renumbered_03.cc b/tests/multigrid/mg_renumbered_03.cc index e67f2c8238..2b6f8d1e2b 100644 --- a/tests/multigrid/mg_renumbered_03.cc +++ b/tests/multigrid/mg_renumbered_03.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2013 by the deal.II authors +// Copyright (C) 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -51,7 +51,6 @@ #include #include -#include #include #include #include @@ -68,7 +67,7 @@ using namespace dealii; template void -reinit_vector (const dealii::MGDoFHandler &mg_dof, +reinit_vector (const dealii::DoFHandler &mg_dof, MGLevelObject > &v) { for (unsigned int level=v.min_level(); @@ -80,12 +79,12 @@ reinit_vector (const dealii::MGDoFHandler &mg_dof, } template -void initialize (const MGDoFHandler &dof, +void initialize (const DoFHandler &dof, Vector &u) { const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; std::vector dof_indices(dofs_per_cell); - for (typename MGDoFHandler::active_cell_iterator + for (typename DoFHandler::active_cell_iterator cell = dof.begin_active(); cell != dof.end(); ++cell) { @@ -101,13 +100,13 @@ void initialize (const MGDoFHandler &dof, template -void initialize (const MGDoFHandler &dof, +void initialize (const DoFHandler &dof, MGLevelObject > &u) { unsigned int counter=0; const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; std::vector dof_indices(dofs_per_cell); - typename MGDoFHandler::cell_iterator + typename DoFHandler::cell_iterator cell = dof.begin(0); cell->get_mg_dof_indices(dof_indices); for (unsigned int i=0; i &dof, template -void diff (Vector &diff, const MGDoFHandler &dof, +void diff (Vector &diff, const DoFHandler &dof, const Vector &v, const unsigned int level) { diff.reinit (v); const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; std::vector mg_dof_indices(dofs_per_cell); const unsigned int n_comp = dof.get_fe().n_components(); - for (typename MGDoFHandler::cell_iterator + for (typename DoFHandler::cell_iterator cell= dof.begin(level); cell != dof.end(level); ++cell) { @@ -142,14 +141,14 @@ void diff (Vector &diff, const MGDoFHandler &dof, } template -void diff (Vector &diff, const MGDoFHandler &dof_1, const MGDoFHandler &dof_2, +void diff (Vector &diff, const DoFHandler &dof_1, const DoFHandler &dof_2, const Vector &u, const Vector &v, const unsigned int level) { diff.reinit (u); const unsigned int dofs_per_cell = dof_1.get_fe().dofs_per_cell; std::vector dof_indices_1(dofs_per_cell); std::vector dof_indices_2(dofs_per_cell); - for (typename MGDoFHandler::cell_iterator + for (typename DoFHandler::cell_iterator cell_1 = dof_1.begin(level), cell_2 = dof_2.begin(level); cell_1 != dof_1.end(level); ++cell_1, ++cell_2) { @@ -161,7 +160,7 @@ void diff (Vector &diff, const MGDoFHandler &dof_1, const MGDoFHand } template -void print(const MGDoFHandler &dof, std::vector > &interface_dofs) +void print(const DoFHandler &dof, std::vector > &interface_dofs) { const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; std::vector dof_indices(dofs_per_cell); @@ -169,7 +168,7 @@ void print(const MGDoFHandler &dof, std::vector > &interf { deallog << std::endl; deallog << "Level " << l << std::endl; - for (typename MGDoFHandler::cell_iterator + for (typename DoFHandler::cell_iterator cell = dof.begin(l); cell != dof.end(l); ++cell) { @@ -223,15 +222,15 @@ public: private: void setup_system (); void test (); - void output_gpl(const MGDoFHandler &dof, + void output_gpl(const DoFHandler &dof, MGLevelObject > &v); void refine_local (); Triangulation triangulation; const MappingQ1 mapping; FESystem fe; - MGDoFHandler mg_dof_handler; - MGDoFHandler mg_dof_handler_renumbered; + DoFHandler mg_dof_handler; + DoFHandler mg_dof_handler_renumbered; const unsigned int degree; std::vector > @@ -253,8 +252,10 @@ LaplaceProblem::LaplaceProblem (const unsigned int deg) : template void LaplaceProblem::setup_system () { - mg_dof_handler.distribute_dofs (fe); + mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs (fe); mg_dof_handler_renumbered.distribute_dofs (fe); + mg_dof_handler_renumbered.distribute_mg_dofs (fe); const unsigned int nlevels = triangulation.n_levels(); @@ -284,7 +285,7 @@ void LaplaceProblem::setup_system () template void -LaplaceProblem::output_gpl(const MGDoFHandler &dof, +LaplaceProblem::output_gpl(const DoFHandler &dof, MGLevelObject > &v) { MeshWorker::IntegrationInfoBox info_box; @@ -309,7 +310,7 @@ LaplaceProblem::output_gpl(const MGDoFHandler &dof, { OutputCreator matrix_integrator; MeshWorker::loop, MeshWorker::IntegrationInfoBox > ( - dof.begin(l), dof.end(l), + dof.begin_mg(l), dof.end_mg(l), dof_info, info_box, std_cxx11::bind(&OutputCreator::cell, &matrix_integrator, std_cxx11::_1, std_cxx11::_2), 0, diff --git a/tests/multigrid/renumbering_01.cc b/tests/multigrid/renumbering_01.cc index 75a0798c88..a34c86fccd 100644 --- a/tests/multigrid/renumbering_01.cc +++ b/tests/multigrid/renumbering_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -15,7 +15,7 @@ // check the new DoFRenumbering::component_wise function that handles -// MGDoFHandlers and renumbers all MG and non-MG dofs +// DoFHandlers and renumbers all MG and non-MG dofs #include "../tests.h" #include @@ -28,7 +28,6 @@ #include #include #include -#include #include #include @@ -50,13 +49,17 @@ void check() tr.begin_active()->set_refine_flag(); tr.execute_coarsening_and_refinement (); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); mgdof.distribute_dofs(fe); + mgdof.distribute_mg_dofs(fe); DoFRenumbering::component_wise (mgdof); + for (unsigned int l=0; l::cell_iterator - cell = mgdof.begin(), - endc = mgdof.end(); + typename DoFHandler::level_cell_iterator + cell = mgdof.begin_mg(), + endc = mgdof.end_mg(); std::vector local_dof_indices (fe.dofs_per_cell); std::vector mg_dof_indices (fe.dofs_per_cell); for (; cell!=endc; ++cell) diff --git a/tests/multigrid/renumbering_02.cc b/tests/multigrid/renumbering_02.cc index 330b3e36a8..8879423b30 100644 --- a/tests/multigrid/renumbering_02.cc +++ b/tests/multigrid/renumbering_02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -15,7 +15,7 @@ // Until version 1.50 of mg_dof_handler.cc, the -// MGDoFHandler::renumbering function could not handle coarsened grids +// DoFHandler::renumbering function could not handle coarsened grids // (unused cells). Check that this works now. #include "../tests.h" @@ -29,7 +29,6 @@ #include #include #include -#include #include #include @@ -53,8 +52,9 @@ void check() cell->set_coarsen_flag(); tria.execute_coarsening_and_refinement (); - MGDoFHandler mg_dof_handler(tria); + DoFHandler mg_dof_handler(tria); mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs(fe); Point a; a(0)=1; for (unsigned int level=0; level #include #include -#include #include #include @@ -55,8 +54,9 @@ void check() cell->set_coarsen_flag(); tria.execute_coarsening_and_refinement (); - MGDoFHandler mg_dof_handler(tria); + DoFHandler mg_dof_handler(tria); mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs(fe); for (unsigned int level=0; level #include -#include #include #include #include @@ -136,7 +135,7 @@ private: Triangulation triangulation; FE_Q fe; - MGDoFHandler mg_dof_handler; + DoFHandler mg_dof_handler; SparsityPattern sparsity_pattern; SparseMatrix system_matrix; @@ -219,7 +218,8 @@ LaplaceProblem::LaplaceProblem (const unsigned int degree) template void LaplaceProblem::setup_system () { - mg_dof_handler.distribute_dofs (fe); + mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs (fe); deallog << "Number of degrees of freedom: " << mg_dof_handler.n_dofs(); @@ -304,7 +304,7 @@ void LaplaceProblem::assemble_system () const Coefficient coefficient; std::vector coefficient_values (n_q_points); - typename MGDoFHandler::active_cell_iterator + typename DoFHandler::active_cell_iterator cell = mg_dof_handler.begin_active(), endc = mg_dof_handler.end(); for (; cell!=endc; ++cell) @@ -360,7 +360,7 @@ void LaplaceProblem::assemble_multigrid (const bool& use_mw) assembler.initialize_interfaces(mg_interface_in, mg_interface_out); MeshWorker::integration_loop ( - mg_dof_handler.begin(), mg_dof_handler.end(), + mg_dof_handler.begin_mg(), mg_dof_handler.end_mg(), dof_info, info_box, matrix_integrator, assembler); const unsigned int nlevels = triangulation.n_levels(); @@ -407,8 +407,8 @@ void LaplaceProblem::assemble_multigrid (const bool& use_mw) boundary_interface_constraints[level].close (); } - typename MGDoFHandler::cell_iterator cell = mg_dof_handler.begin(), - endc = mg_dof_handler.end(); + typename DoFHandler::level_cell_iterator cell = mg_dof_handler.begin_mg(), + endc = mg_dof_handler.end_mg(); for (; cell!=endc; ++cell) { diff --git a/tests/multigrid/step-16-bdry1.cc b/tests/multigrid/step-16-bdry1.cc index 362060b79b..5b6738905c 100644 --- a/tests/multigrid/step-16-bdry1.cc +++ b/tests/multigrid/step-16-bdry1.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2003 - 2013 by the deal.II authors +// Copyright (C) 2003 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -51,7 +51,6 @@ #include #include -#include #include #include #include @@ -137,7 +136,7 @@ private: Triangulation triangulation; FE_Q fe; - MGDoFHandler mg_dof_handler; + DoFHandler mg_dof_handler; SparsityPattern sparsity_pattern; SparseMatrix system_matrix; @@ -220,7 +219,8 @@ LaplaceProblem::LaplaceProblem (const unsigned int degree) template void LaplaceProblem::setup_system () { - mg_dof_handler.distribute_dofs (fe); + mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs (fe); deallog << "Number of degrees of freedom: " << mg_dof_handler.n_dofs(); @@ -305,7 +305,7 @@ void LaplaceProblem::assemble_system () const Coefficient coefficient; std::vector coefficient_values (n_q_points); - typename MGDoFHandler::active_cell_iterator + typename DoFHandler::active_cell_iterator cell = mg_dof_handler.begin_active(), endc = mg_dof_handler.end(); for (; cell!=endc; ++cell) @@ -361,7 +361,7 @@ void LaplaceProblem::assemble_multigrid (const bool& use_mw) assembler.initialize_interfaces(mg_interface_in, mg_interface_out); MeshWorker::integration_loop ( - mg_dof_handler.begin(), mg_dof_handler.end(), + mg_dof_handler.begin_mg(), mg_dof_handler.end_mg(), dof_info, info_box, matrix_integrator, assembler); const unsigned int nlevels = triangulation.n_levels(); @@ -408,8 +408,8 @@ void LaplaceProblem::assemble_multigrid (const bool& use_mw) boundary_interface_constraints[level].close (); } - typename MGDoFHandler::cell_iterator cell = mg_dof_handler.begin(), - endc = mg_dof_handler.end(); + typename DoFHandler::level_cell_iterator cell = mg_dof_handler.begin_mg(), + endc = mg_dof_handler.end_mg(); for (; cell!=endc; ++cell) { diff --git a/tests/multigrid/step-16.cc b/tests/multigrid/step-16.cc index 7443afc242..58f62c727c 100644 --- a/tests/multigrid/step-16.cc +++ b/tests/multigrid/step-16.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2003 - 2013 by the deal.II authors +// Copyright (C) 2003 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -47,7 +47,6 @@ #include #include -#include #include #include #include @@ -77,7 +76,7 @@ private: Triangulation triangulation; FE_Q fe; - MGDoFHandler mg_dof_handler; + DoFHandler mg_dof_handler; SparsityPattern sparsity_pattern; SparseMatrix system_matrix; @@ -157,7 +156,8 @@ LaplaceProblem::LaplaceProblem (const unsigned int degree) template void LaplaceProblem::setup_system () { - mg_dof_handler.distribute_dofs (fe); + mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs (fe); deallog << "Number of degrees of freedom: " << mg_dof_handler.n_dofs(); @@ -239,7 +239,7 @@ void LaplaceProblem::assemble_system () const Coefficient coefficient; std::vector coefficient_values (n_q_points); - typename MGDoFHandler::active_cell_iterator + typename DoFHandler::active_cell_iterator cell = mg_dof_handler.begin_active(), endc = mg_dof_handler.end(); for (; cell!=endc; ++cell) @@ -311,7 +311,7 @@ void LaplaceProblem::assemble_multigrid () boundary_interface_constraints[level].close (); } - typename MGDoFHandler::cell_iterator cell = mg_dof_handler.begin(), + typename DoFHandler::cell_iterator cell = mg_dof_handler.begin(), endc = mg_dof_handler.end(); for (; cell!=endc; ++cell) @@ -416,7 +416,7 @@ void LaplaceProblem::assemble_multigrid () // problem under consideration. In that case, // we can use the MGTransferPrebuilt class // that, given the constraints on the global -// level and an MGDoFHandler object computes +// level and an DoFHandler object computes // the matrices corresponding to these // transfer operators. // @@ -492,7 +492,7 @@ void LaplaceProblem::solve () // exception of two minor differences: The // KellyErrorEstimator::estimate function // wants an argument of type DoFHandler, not -// MGDoFHandler, and so we have to cast from +// DoFHandler, and so we have to cast from // derived to base class; and we generate // output in VTK format, to use the more // modern visualization programs available diff --git a/tests/multigrid/step-39-02.cc b/tests/multigrid/step-39-02.cc index f967ba8571..afc3ea726e 100644 --- a/tests/multigrid/step-39-02.cc +++ b/tests/multigrid/step-39-02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2013 by the deal.II authors +// Copyright (C) 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -31,7 +31,6 @@ #include #include #include -#include #include #include @@ -359,7 +358,7 @@ namespace Step39 Triangulation triangulation; const MappingQ1 mapping; const FiniteElement &fe; - MGDoFHandler mg_dof_handler; + DoFHandler mg_dof_handler; DoFHandler &dof_handler; SparsityPattern sparsity; @@ -396,6 +395,7 @@ namespace Step39 InteriorPenaltyProblem::setup_system() { dof_handler.distribute_dofs(fe); + dof_handler.distribute_mg_dofs(fe); types::global_dof_index n_dofs = dof_handler.n_dofs(); solution.reinit(n_dofs); right_hand_side.reinit(n_dofs); @@ -479,7 +479,7 @@ namespace Step39 MatrixIntegrator integrator; MeshWorker::integration_loop ( - mg_dof_handler.begin(), mg_dof_handler.end(), + mg_dof_handler.begin_mg(), mg_dof_handler.end_mg(), dof_info, info_box, integrator, assembler); diff --git a/tests/multigrid/step-39-02a.cc b/tests/multigrid/step-39-02a.cc index 299cd19903..0cb57b9900 100644 --- a/tests/multigrid/step-39-02a.cc +++ b/tests/multigrid/step-39-02a.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2013 by the deal.II authors +// Copyright (C) 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -31,7 +31,6 @@ #include #include #include -#include #include #include @@ -360,7 +359,7 @@ namespace Step39 Triangulation triangulation; const MappingQ1 mapping; const FiniteElement &fe; - MGDoFHandler mg_dof_handler; + DoFHandler mg_dof_handler; DoFHandler &dof_handler; MGConstrainedDoFs mg_constraints; @@ -398,6 +397,7 @@ namespace Step39 InteriorPenaltyProblem::setup_system() { dof_handler.distribute_dofs(fe); + dof_handler.distribute_mg_dofs(fe); unsigned int n_dofs = dof_handler.n_dofs(); solution.reinit(n_dofs); right_hand_side.reinit(n_dofs); @@ -485,7 +485,7 @@ namespace Step39 MatrixIntegrator integrator; MeshWorker::integration_loop ( - mg_dof_handler.begin(), mg_dof_handler.end(), + mg_dof_handler.begin_mg(), mg_dof_handler.end_mg(), dof_info, info_box, integrator, assembler); diff --git a/tests/multigrid/step-39-03.cc b/tests/multigrid/step-39-03.cc index 028bce9d85..0d089733f5 100644 --- a/tests/multigrid/step-39-03.cc +++ b/tests/multigrid/step-39-03.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2013 by the deal.II authors +// Copyright (C) 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -37,7 +37,6 @@ #include #include #include -#include #include #include @@ -365,7 +364,7 @@ namespace Step39 Triangulation triangulation; const MappingQ1 mapping; const FiniteElement &fe; - MGDoFHandler mg_dof_handler; + DoFHandler mg_dof_handler; DoFHandler &dof_handler; SparsityPattern sparsity; @@ -402,6 +401,7 @@ namespace Step39 InteriorPenaltyProblem::setup_system() { dof_handler.distribute_dofs(fe); + dof_handler.distribute_mg_dofs(fe); types::global_dof_index n_dofs = dof_handler.n_dofs(); solution.reinit(n_dofs); right_hand_side.reinit(n_dofs); @@ -485,7 +485,7 @@ namespace Step39 MatrixIntegrator integrator; MeshWorker::integration_loop ( - mg_dof_handler.begin(), mg_dof_handler.end(), + mg_dof_handler.begin_mg(), mg_dof_handler.end_mg(), dof_info, info_box, integrator, assembler); diff --git a/tests/multigrid/step-39.cc b/tests/multigrid/step-39.cc index 0b6d4a6265..463606982d 100644 --- a/tests/multigrid/step-39.cc +++ b/tests/multigrid/step-39.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2010 - 2013 by the deal.II authors +// Copyright (C) 2010 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -32,7 +32,6 @@ #include #include #include -#include #include #include @@ -360,7 +359,7 @@ namespace Step39 Triangulation triangulation; const MappingQ1 mapping; const FiniteElement &fe; - MGDoFHandler mg_dof_handler; + DoFHandler mg_dof_handler; DoFHandler &dof_handler; SparsityPattern sparsity; @@ -396,6 +395,7 @@ namespace Step39 InteriorPenaltyProblem::setup_system() { dof_handler.distribute_dofs(fe); + dof_handler.distribute_mg_dofs(fe); unsigned int n_dofs = dof_handler.n_dofs(); solution.reinit(n_dofs); right_hand_side.reinit(n_dofs); @@ -475,7 +475,7 @@ namespace Step39 MatrixIntegrator integrator; MeshWorker::integration_loop ( - mg_dof_handler.begin(), mg_dof_handler.end(), + mg_dof_handler.begin_mg(), mg_dof_handler.end_mg(), dof_info, info_box, integrator, assembler); } diff --git a/tests/multigrid/transfer_01.cc b/tests/multigrid/transfer_01.cc index 470b73ea93..1534e8a8cf 100644 --- a/tests/multigrid/transfer_01.cc +++ b/tests/multigrid/transfer_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -30,7 +30,6 @@ #include #include #include -#include #include #include @@ -43,7 +42,7 @@ using namespace std; template void -reinit_vector (const dealii::MGDoFHandler &mg_dof, +reinit_vector (const dealii::DoFHandler &mg_dof, MGLevelObject > &v) { for (unsigned int level=v.min_level(); @@ -65,8 +64,9 @@ void check_simple(const FiniteElement &fe) GridGenerator::hyper_cube(tr); tr.refine_global(2); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); mgdof.distribute_dofs(fe); + mgdof.distribute_mg_dofs(fe); MGTransferPrebuilt > transfer; transfer.build_matrices(mgdof); diff --git a/tests/multigrid/transfer_02.cc b/tests/multigrid/transfer_02.cc index 7b877ec1a7..7b102f13dd 100644 --- a/tests/multigrid/transfer_02.cc +++ b/tests/multigrid/transfer_02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -34,7 +34,6 @@ #include #include #include -#include #include #include @@ -47,7 +46,7 @@ using namespace std; template void -reinit_vector (const dealii::MGDoFHandler &mg_dof, +reinit_vector (const dealii::DoFHandler &mg_dof, MGLevelObject > &v) { for (unsigned int level=v.min_level(); @@ -95,8 +94,9 @@ void check_simple(const FiniteElement &fe) refine_mesh(tr); refine_mesh(tr); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); mgdof.distribute_dofs(fe); + mgdof.distribute_mg_dofs(fe); MGTransferPrebuilt > transfer; transfer.build_matrices(mgdof); diff --git a/tests/multigrid/transfer_03.cc b/tests/multigrid/transfer_03.cc index f81e164eae..f2ccccd2df 100644 --- a/tests/multigrid/transfer_03.cc +++ b/tests/multigrid/transfer_03.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -35,7 +35,6 @@ #include #include #include -#include #include #include #include @@ -49,7 +48,7 @@ using namespace std; template void -reinit_vector (const dealii::MGDoFHandler &mg_dof, +reinit_vector (const dealii::DoFHandler &mg_dof, MGLevelObject > &v) { for (unsigned int level=v.min_level(); @@ -96,13 +95,13 @@ void refine_mesh (Triangulation &triangulation) } template -void initialize (const MGDoFHandler &dof, +void initialize (const DoFHandler &dof, Vector &u) { unsigned int counter=0; const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; std::vector dof_indices(dofs_per_cell); - for (typename MGDoFHandler::active_cell_iterator + for (typename DoFHandler::active_cell_iterator cell = dof.begin_active(); cell != dof.end(); ++cell) { @@ -113,13 +112,13 @@ void initialize (const MGDoFHandler &dof, } template -void initialize (const MGDoFHandler &dof, +void initialize (const DoFHandler &dof, MGLevelObject > &u) { unsigned int counter=0; const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; std::vector dof_indices(dofs_per_cell); - typename MGDoFHandler::cell_iterator + typename DoFHandler::cell_iterator cell = dof.begin(0); cell->get_mg_dof_indices(dof_indices); for (unsigned int i=0; i &dof, } template -void print (const MGDoFHandler &dof, +void print (const DoFHandler &dof, MGLevelObject > &u) { const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; @@ -136,7 +135,7 @@ void print (const MGDoFHandler &dof, { deallog << std::endl; deallog << "Level " << l << std::endl; - for (typename MGDoFHandler::cell_iterator + for (typename DoFHandler::cell_iterator cell = dof.begin(l); cell != dof.end(l); ++cell) { @@ -148,7 +147,7 @@ void print (const MGDoFHandler &dof, } template -void print_diff (const MGDoFHandler &dof_1, const MGDoFHandler &dof_2, +void print_diff (const DoFHandler &dof_1, const DoFHandler &dof_2, const Vector &u, const Vector &v) { Vector diff; @@ -156,7 +155,7 @@ void print_diff (const MGDoFHandler &dof_1, const MGDoFHandler &dof_2, const unsigned int dofs_per_cell = dof_1.get_fe().dofs_per_cell; std::vector dof_indices_1(dofs_per_cell); std::vector dof_indices_2(dofs_per_cell); - for (typename MGDoFHandler::active_cell_iterator + for (typename DoFHandler::active_cell_iterator cell_1 = dof_1.begin_active(), cell_2 = dof_2.begin_active(); cell_1 != dof_1.end(); ++cell_1, ++cell_2) { @@ -185,11 +184,13 @@ void check_simple(const FiniteElement &fe) refine_mesh(tr); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); mgdof.distribute_dofs(fe); + mgdof.distribute_mg_dofs(fe); - MGDoFHandler mgdof_renumbered(tr); + DoFHandler mgdof_renumbered(tr); mgdof_renumbered.distribute_dofs(fe); + mgdof_renumbered.distribute_mg_dofs(fe); std::vector block_component (4,0); block_component[2] = 1; diff --git a/tests/multigrid/transfer_block.cc b/tests/multigrid/transfer_block.cc index cafd85b759..198d9d4918 100644 --- a/tests/multigrid/transfer_block.cc +++ b/tests/multigrid/transfer_block.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -29,7 +29,6 @@ #include #include #include -#include #include #include @@ -44,7 +43,7 @@ using namespace std; template void reinit_vector_by_blocks ( - const dealii::MGDoFHandler &mg_dof, + const dealii::DoFHandler &mg_dof, MGLevelObject > &v, const std::vector &sel, std::vector > &ndofs) @@ -96,9 +95,10 @@ void check_block(const FiniteElement &fe, GridGenerator::hyper_cube(tr); tr.refine_global(2); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); DoFHandler &dof=mgdof; mgdof.distribute_dofs(fe); + mgdof.distribute_mg_dofs(fe); DoFRenumbering::component_wise(mgdof); vector ndofs(fe.n_blocks()); DoFTools::count_dofs_per_block(mgdof, ndofs); diff --git a/tests/multigrid/transfer_block_select.cc b/tests/multigrid/transfer_block_select.cc index 6ff513eb60..166d76f33a 100644 --- a/tests/multigrid/transfer_block_select.cc +++ b/tests/multigrid/transfer_block_select.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -29,7 +29,6 @@ #include #include #include -#include #include #include @@ -44,7 +43,7 @@ using namespace std; template void reinit_vector_by_blocks ( - const dealii::MGDoFHandler &mg_dof, + const dealii::DoFHandler &mg_dof, MGLevelObject > &v, const unsigned int selected_block, std::vector > &ndofs) @@ -82,9 +81,10 @@ void check_select(const FiniteElement &fe, unsigned int selected) GridGenerator::hyper_cube(tr); tr.refine_global(2); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); DoFHandler &dof=mgdof; mgdof.distribute_dofs(fe); + mgdof.distribute_mg_dofs(fe); DoFRenumbering::component_wise(mgdof); vector ndofs(fe.n_blocks()); DoFTools::count_dofs_per_block(mgdof, ndofs); diff --git a/tests/multigrid/transfer_compare_01.cc b/tests/multigrid/transfer_compare_01.cc index 91ee1d4363..0eed3fe3d7 100644 --- a/tests/multigrid/transfer_compare_01.cc +++ b/tests/multigrid/transfer_compare_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -30,7 +30,6 @@ #include #include #include -#include #include #include #include @@ -47,7 +46,7 @@ using namespace std; template void reinit_vector_by_blocks ( - const dealii::MGDoFHandler &mg_dof, + const dealii::DoFHandler &mg_dof, MGLevelObject > &v, const unsigned int selected_block, std::vector > &ndofs) @@ -78,7 +77,7 @@ reinit_vector_by_blocks ( template void reinit_vector_by_blocks ( - const dealii::MGDoFHandler &mg_dof, + const dealii::DoFHandler &mg_dof, MGLevelObject > &v, const std::vector &sel, std::vector > &ndofs) @@ -128,9 +127,10 @@ void check_block(const FiniteElement &fe) GridGenerator::hyper_cube(tr); tr.refine_global(2); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); DoFHandler &dof=mgdof; mgdof.distribute_dofs(fe); + mgdof.distribute_mg_dofs(fe); // Make sure all orderings are the // same diff --git a/tests/multigrid/transfer_prebuilt_01.cc b/tests/multigrid/transfer_prebuilt_01.cc index 923bbe45e2..a7fcb0af5f 100644 --- a/tests/multigrid/transfer_prebuilt_01.cc +++ b/tests/multigrid/transfer_prebuilt_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -30,7 +30,6 @@ #include #include #include -#include #include #include @@ -54,8 +53,9 @@ void check_simple(const FiniteElement &fe) tr.begin(2)->set_refine_flag(); tr.execute_coarsening_and_refinement(); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); mgdof.distribute_dofs(fe); + mgdof.distribute_mg_dofs(fe); MGTransferPrebuilt > transfer; transfer.build_matrices(mgdof); diff --git a/tests/multigrid/transfer_prebuilt_02.cc b/tests/multigrid/transfer_prebuilt_02.cc index 5985a2aba1..ffe3c142e8 100644 --- a/tests/multigrid/transfer_prebuilt_02.cc +++ b/tests/multigrid/transfer_prebuilt_02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -30,7 +30,6 @@ #include #include #include -#include #include #include #include @@ -55,8 +54,9 @@ void check_simple(const FiniteElement &fe) tr.begin(2)->set_refine_flag(); tr.execute_coarsening_and_refinement(); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); mgdof.distribute_dofs(fe); + mgdof.distribute_mg_dofs(fe); ConstraintMatrix hanging_node_constraints; DoFTools::make_hanging_node_constraints (mgdof, hanging_node_constraints); diff --git a/tests/multigrid/transfer_prebuilt_03.cc b/tests/multigrid/transfer_prebuilt_03.cc index 0040a0381d..0011c4de42 100644 --- a/tests/multigrid/transfer_prebuilt_03.cc +++ b/tests/multigrid/transfer_prebuilt_03.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -31,7 +31,6 @@ #include #include #include -#include #include #include #include @@ -56,8 +55,9 @@ void check_simple(const FiniteElement &fe) tr.begin(2)->set_refine_flag(); tr.execute_coarsening_and_refinement(); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); mgdof.distribute_dofs(fe); + mgdof.distribute_mg_dofs(fe); ConstraintMatrix hanging_node_constraints; DoFTools::make_hanging_node_constraints (mgdof, hanging_node_constraints); diff --git a/tests/multigrid/transfer_select.cc b/tests/multigrid/transfer_select.cc index 7a9c2b2b91..e0fcd455a8 100644 --- a/tests/multigrid/transfer_select.cc +++ b/tests/multigrid/transfer_select.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -28,7 +28,6 @@ #include #include #include -#include #include #include @@ -55,9 +54,10 @@ void check_select(const FiniteElement &fe, GridGenerator::hyper_cube(tr); tr.refine_global(2); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); DoFHandler &dof=mgdof; mgdof.distribute_dofs(fe); + mgdof.distribute_mg_dofs(fe); DoFRenumbering::component_wise(static_cast&>(mgdof), target_component); vector ndofs(*std::max_element (target_component.begin(), diff --git a/tests/multigrid/transfer_system_01.cc b/tests/multigrid/transfer_system_01.cc index f216b0cf16..883c84390e 100644 --- a/tests/multigrid/transfer_system_01.cc +++ b/tests/multigrid/transfer_system_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -27,7 +27,6 @@ #include #include #include -#include #include #include @@ -40,7 +39,7 @@ using namespace std; template void -reinit_vector (const dealii::MGDoFHandler &mg_dof, +reinit_vector (const dealii::DoFHandler &mg_dof, MGLevelObject > &v) { for (unsigned int level=v.min_level(); @@ -95,8 +94,9 @@ void check (const FiniteElement &fe) GridGenerator::hyper_cube(tr); tr.refine_global(2); - MGDoFHandler mg_dof_handler(tr); + DoFHandler mg_dof_handler(tr); mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs(fe); DoFRenumbering::component_wise (mg_dof_handler); for (unsigned int level=0; level #include #include -#include #include #include #include @@ -41,7 +40,7 @@ using namespace std; template void -reinit_vector (const dealii::MGDoFHandler &mg_dof, +reinit_vector (const dealii::DoFHandler &mg_dof, MGLevelObject > &v) { for (unsigned int level=v.min_level(); @@ -96,8 +95,9 @@ void check (const FiniteElement &fe) GridGenerator::hyper_cube(tr); tr.refine_global(2); - MGDoFHandler mg_dof_handler(tr); + DoFHandler mg_dof_handler(tr); mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs(fe); DoFRenumbering::component_wise (mg_dof_handler); for (unsigned int level=0; level #include #include -#include #include #include #include @@ -41,7 +40,7 @@ using namespace std; template void -reinit_vector (const dealii::MGDoFHandler &mg_dof, +reinit_vector (const dealii::DoFHandler &mg_dof, MGLevelObject > &v) { for (unsigned int level=v.min_level(); @@ -96,8 +95,9 @@ void check (const FiniteElement &fe) GridGenerator::hyper_cube(tr); tr.refine_global(2); - MGDoFHandler mg_dof_handler(tr); + DoFHandler mg_dof_handler(tr); mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs(fe); DoFRenumbering::component_wise (mg_dof_handler); for (unsigned int level=0; level #include #include -#include #include #include #include @@ -41,7 +40,7 @@ using namespace std; template void -reinit_vector (const dealii::MGDoFHandler &mg_dof, +reinit_vector (const dealii::DoFHandler &mg_dof, MGLevelObject > &v) { for (unsigned int level=v.min_level(); @@ -96,8 +95,9 @@ void check (const FiniteElement &fe) GridGenerator::hyper_cube(tr); tr.refine_global(2); - MGDoFHandler mg_dof_handler(tr); + DoFHandler mg_dof_handler(tr); mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs(fe); std::vector block_component(3,0); block_component[2]=1; diff --git a/tests/multigrid/transfer_system_05.cc b/tests/multigrid/transfer_system_05.cc index a2798ae552..928c4f5b1f 100644 --- a/tests/multigrid/transfer_system_05.cc +++ b/tests/multigrid/transfer_system_05.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -27,7 +27,6 @@ #include #include #include -#include #include #include #include @@ -49,8 +48,9 @@ void check (const FiniteElement &fe, const unsigned int selected_block) GridGenerator::hyper_cube(tr); tr.refine_global(2); - MGDoFHandler mg_dof_handler(tr); + DoFHandler mg_dof_handler(tr); mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs(fe); std::vector block_component(5,0); block_component[2]=1; diff --git a/tests/multigrid/transfer_system_adaptive_01.cc b/tests/multigrid/transfer_system_adaptive_01.cc index 4a7e7c1ca4..157f223c18 100644 --- a/tests/multigrid/transfer_system_adaptive_01.cc +++ b/tests/multigrid/transfer_system_adaptive_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -30,7 +30,6 @@ #include #include #include -#include #include #include @@ -43,7 +42,7 @@ using namespace std; template void -reinit_vector (const dealii::MGDoFHandler &mg_dof, +reinit_vector (const dealii::DoFHandler &mg_dof, MGLevelObject > &v) { for (unsigned int level=v.min_level(); @@ -131,8 +130,9 @@ void check (const FiniteElement &fe) subdivisions, bottom_left, top_right, true); refine_mesh(tr); - MGDoFHandler mg_dof_handler(tr); + DoFHandler mg_dof_handler(tr); mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs(fe); deallog << "Global dofs: " << mg_dof_handler.n_dofs() << std::endl; for (unsigned int l=0; l #include #include -#include #include #include @@ -43,7 +42,7 @@ using namespace std; template void -reinit_vector (const dealii::MGDoFHandler &mg_dof, +reinit_vector (const dealii::DoFHandler &mg_dof, MGLevelObject > &v) { for (unsigned int level=v.min_level(); @@ -131,8 +130,9 @@ void check (const FiniteElement &fe) subdivisions, bottom_left, top_right, true); refine_mesh(tr); - MGDoFHandler mg_dof_handler(tr); + DoFHandler mg_dof_handler(tr); mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs(fe); deallog << "Global dofs: " << mg_dof_handler.n_dofs() << std::endl; for (unsigned int l=0; l #include #include -#include #include #include #include @@ -44,7 +43,7 @@ using namespace std; template void -reinit_vector (const dealii::MGDoFHandler &mg_dof, +reinit_vector (const dealii::DoFHandler &mg_dof, MGLevelObject > &v) { for (unsigned int level=v.min_level(); @@ -132,8 +131,9 @@ void check (const FiniteElement &fe) subdivisions, bottom_left, top_right, true); refine_mesh(tr); - MGDoFHandler mg_dof_handler(tr); + DoFHandler mg_dof_handler(tr); mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs(fe); deallog << "Global dofs: " << mg_dof_handler.n_dofs() << std::endl; for (unsigned int l=0; l #include #include -#include #include #include #include @@ -43,7 +42,7 @@ using namespace std; template void -reinit_vector (const dealii::MGDoFHandler &mg_dof, +reinit_vector (const dealii::DoFHandler &mg_dof, MGLevelObject > &v) { for (unsigned int level=v.min_level(); @@ -131,8 +130,9 @@ void check (const FiniteElement &fe) subdivisions, bottom_left, top_right, true); refine_mesh(tr); - MGDoFHandler mg_dof_handler(tr); + DoFHandler mg_dof_handler(tr); mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs(fe); deallog << "Global dofs: " << mg_dof_handler.n_dofs() << std::endl; for (unsigned int l=0; l #include #include -#include #include #include #include @@ -44,7 +43,7 @@ using namespace std; template void -reinit_vector (const dealii::MGDoFHandler &mg_dof, +reinit_vector (const dealii::DoFHandler &mg_dof, MGLevelObject > &v) { for (unsigned int level=v.min_level(); @@ -132,8 +131,9 @@ void check (const FiniteElement &fe) subdivisions, bottom_left, top_right, true); refine_mesh(tr); - MGDoFHandler mg_dof_handler(tr); + DoFHandler mg_dof_handler(tr); mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs(fe); deallog << "Global dofs: " << mg_dof_handler.n_dofs() << std::endl; for (unsigned int l=0; l #include #include -#include #include #include #include @@ -43,7 +42,7 @@ using namespace std; template void -reinit_vector (const dealii::MGDoFHandler &mg_dof, +reinit_vector (const dealii::DoFHandler &mg_dof, MGLevelObject > &v) { for (unsigned int level=v.min_level(); @@ -131,8 +130,9 @@ void check (const FiniteElement &fe) subdivisions, bottom_left, top_right, true); refine_mesh(tr); - MGDoFHandler mg_dof_handler(tr); + DoFHandler mg_dof_handler(tr); mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs(fe); deallog << "Global dofs: " << mg_dof_handler.n_dofs() << std::endl; for (unsigned int l=0; l #include #include -#include #include #include #include @@ -45,7 +44,7 @@ using namespace std; template void -reinit_vector (const dealii::MGDoFHandler &mg_dof, +reinit_vector (const dealii::DoFHandler &mg_dof, MGLevelObject > &v) { for (unsigned int level=v.min_level(); @@ -133,8 +132,9 @@ void check (const FiniteElement &fe) subdivisions, bottom_left, top_right, true); refine_mesh(tr); - MGDoFHandler mg_dof_handler(tr); + DoFHandler mg_dof_handler(tr); mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs(fe); std::vector block_selected(3,0); block_selected[2] = 1; diff --git a/tests/multigrid/transfer_system_adaptive_08.cc b/tests/multigrid/transfer_system_adaptive_08.cc index 2fe84064b5..ad4e7e4a89 100644 --- a/tests/multigrid/transfer_system_adaptive_08.cc +++ b/tests/multigrid/transfer_system_adaptive_08.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -30,7 +30,6 @@ #include #include #include -#include #include #include #include @@ -44,7 +43,7 @@ using namespace std; template void -reinit_vector (const dealii::MGDoFHandler &mg_dof, +reinit_vector (const dealii::DoFHandler &mg_dof, MGLevelObject > &v) { for (unsigned int level=v.min_level(); @@ -132,8 +131,9 @@ void check (const FiniteElement &fe) subdivisions, bottom_left, top_right, true); refine_mesh(tr); - MGDoFHandler mg_dof_handler(tr); + DoFHandler mg_dof_handler(tr); mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs(fe); std::vector block_selected(3,0); block_selected[2] = 1; diff --git a/tests/multigrid/transfer_system_adaptive_09.cc b/tests/multigrid/transfer_system_adaptive_09.cc index 891bdce57a..1ccf4964ee 100644 --- a/tests/multigrid/transfer_system_adaptive_09.cc +++ b/tests/multigrid/transfer_system_adaptive_09.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2013 by the deal.II authors +// Copyright (C) 2000 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -30,7 +30,6 @@ #include #include #include -#include #include #include #include @@ -92,8 +91,9 @@ void check (const FiniteElement &fe, const unsigned int selected_block) // grid_out.write_eps (tr, grid_output); - MGDoFHandler mg_dof_handler(tr); + DoFHandler mg_dof_handler(tr); mg_dof_handler.distribute_dofs(fe); + mg_dof_handler.distribute_mg_dofs(fe); std::vector block_component(5,0); block_component[2]=1; diff --git a/tests/trilinos/mg_transfer_prebuilt_01.cc b/tests/trilinos/mg_transfer_prebuilt_01.cc index 6a53a7dd65..393a0e7278 100644 --- a/tests/trilinos/mg_transfer_prebuilt_01.cc +++ b/tests/trilinos/mg_transfer_prebuilt_01.cc @@ -27,7 +27,6 @@ #include #include #include -#include #include #include @@ -40,7 +39,7 @@ using namespace std; template void -reinit_vector (const dealii::MGDoFHandler &mg_dof, +reinit_vector (const dealii::DoFHandler &mg_dof, MGLevelObject &v) { const dealii::parallel::distributed::Triangulation *tria = @@ -69,8 +68,9 @@ void check_simple(const FiniteElement &fe) GridGenerator::hyper_cube(tr); tr.refine_global(2); - MGDoFHandler mgdof(tr); + DoFHandler mgdof(tr); mgdof.distribute_dofs(fe); + mgdof.distribute_mg_dofs(fe); MGTransferPrebuilt transfer; transfer.build_matrices(mgdof); -- 2.39.5