From 856f4ec46527a6ab8c0da10c191037585e3a98e0 Mon Sep 17 00:00:00 2001 From: heister Date: Fri, 21 Dec 2012 02:07:39 +0000 Subject: [PATCH] remove some nonsense comments and revert whitespace git-svn-id: https://svn.dealii.org/branches/branch_merge_mg_into_dof_handler@27843 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/source/hp/dof_handler.cc | 83 +++++++++++--------------------- 1 file changed, 27 insertions(+), 56 deletions(-) diff --git a/deal.II/source/hp/dof_handler.cc b/deal.II/source/hp/dof_handler.cc index 840028b260..c78764fceb 100644 --- a/deal.II/source/hp/dof_handler.cc +++ b/deal.II/source/hp/dof_handler.cc @@ -1638,6 +1638,7 @@ namespace hp } + /*------------------------ Cell iterator functions ------------------------*/ template @@ -1697,8 +1698,6 @@ namespace hp } - - //------------------------------------------------------------------ @@ -1826,7 +1825,6 @@ namespace hp } - template <> unsigned int DoFHandler<1,3>::n_boundary_dofs () const { @@ -2023,7 +2021,7 @@ namespace hp // vertices at all, I can't think // of a finite element that would // make that necessary... - Table<2,std_cxx1x::shared_ptr > + Table<2,std_cxx1x::shared_ptr > vertex_dof_identities (get_fe().size(), get_fe().size()); @@ -2034,13 +2032,13 @@ namespace hp ++vertex_index) { const unsigned int n_active_fe_indices - = dealii::internal::DoFAccessor::Implementation:: + = internal::DoFAccessor::Implementation:: n_active_vertex_fe_indices (*this, vertex_index); if (n_active_fe_indices > 1) { const unsigned int first_fe_index - = dealii::internal::DoFAccessor::Implementation:: + = internal::DoFAccessor::Implementation:: nth_active_vertex_fe_index (*this, vertex_index, 0); // loop over all the @@ -2052,14 +2050,14 @@ namespace hp { const unsigned int other_fe_index - = dealii::internal::DoFAccessor::Implementation:: + = internal::DoFAccessor::Implementation:: nth_active_vertex_fe_index (*this, vertex_index, f); // make sure the // entry in the // equivalence // table exists - dealii::internal::hp::ensure_existence_of_dof_identities<0> + internal::hp::ensure_existence_of_dof_identities<0> (get_fe()[first_fe_index], get_fe()[other_fe_index], vertex_dof_identities[first_fe_index][other_fe_index]); @@ -2088,18 +2086,18 @@ namespace hp // lower, to avoid // circular // reasoning. - dealii::internal::hp::DoFIdentities &identities + internal::hp::DoFIdentities &identities = *vertex_dof_identities[first_fe_index][other_fe_index]; for (unsigned int i=0; i void DoFHandler<1,1>:: @@ -2574,7 +2573,7 @@ namespace hp // then allocate space for all // the other tables - dealii::internal::hp::DoFHandler::Implementation::reserve_space (*this); + internal::hp::DoFHandler::Implementation::reserve_space (*this); // Clear user flags because we will // need them. But first we save @@ -2600,7 +2599,7 @@ namespace hp for (; cell != endc; ++cell) next_free_dof - = dealii::internal::hp::DoFHandler::Implementation::template distribute_dofs_on_cell (cell, + = internal::hp::DoFHandler::Implementation::template distribute_dofs_on_cell (cell, next_free_dof); number_cache.n_global_dofs = next_free_dof; @@ -2659,7 +2658,7 @@ namespace hp // finally, do the renumbering // and set the number of actually // used dof indices - renumber_dofs_internal (new_dof_indices, dealii::internal::int2type()); + renumber_dofs_internal (new_dof_indices, internal::int2type()); // now set the elements of the // number cache appropriately @@ -2715,7 +2714,7 @@ namespace hp } #endif - renumber_dofs_internal (new_numbers, dealii::internal::int2type()); + renumber_dofs_internal (new_numbers, internal::int2type()); } @@ -2724,7 +2723,7 @@ namespace hp void DoFHandler:: renumber_dofs_internal (const std::vector &new_numbers, - dealii::internal::int2type<0>) + internal::int2type<0>) { Assert (new_numbers.size() == n_dofs(), ExcRenumberingIncomplete()); @@ -2732,24 +2731,24 @@ namespace hp ++vertex_index) { const unsigned int n_active_fe_indices - = dealii::internal::DoFAccessor::Implementation:: + = internal::DoFAccessor::Implementation:: n_active_vertex_fe_indices (*this, vertex_index); for (unsigned int f=0; f:: renumber_dofs_internal (const std::vector &new_numbers, - dealii::internal::int2type<1>) + internal::int2type<1>) { Assert (new_numbers.size() == n_dofs(), ExcRenumberingIncomplete()); @@ -2810,13 +2809,12 @@ namespace hp } - //TODO: Merge the following three functions -- they are identical template<> void DoFHandler<2,2>:: renumber_dofs_internal (const std::vector &new_numbers, - dealii::internal::int2type<2>) + internal::int2type<2>) { const unsigned int dim = 2; const unsigned int spacedim = 2; @@ -2868,7 +2866,7 @@ namespace hp void DoFHandler<2,3>:: renumber_dofs_internal (const std::vector &new_numbers, - dealii::internal::int2type<2>) + internal::int2type<2>) { const unsigned int dim = 2; const unsigned int spacedim = 3; @@ -2919,7 +2917,7 @@ namespace hp void DoFHandler<3,3>:: renumber_dofs_internal (const std::vector &new_numbers, - dealii::internal::int2type<2>) + internal::int2type<2>) { const unsigned int dim = 3; const unsigned int spacedim = 3; @@ -2970,7 +2968,7 @@ namespace hp void DoFHandler<3,3>:: renumber_dofs_internal (const std::vector &new_numbers, - dealii::internal::int2type<3>) + internal::int2type<3>) { const unsigned int dim = 3; const unsigned int spacedim = 3; @@ -3026,7 +3024,7 @@ namespace hp DoFHandler::max_couplings_between_dofs () const { Assert (finite_elements != 0, ExcNoFESelected()); - return dealii::internal::hp::DoFHandler::Implementation::max_couplings_between_dofs (*this); + return internal::hp::DoFHandler::Implementation::max_couplings_between_dofs (*this); } @@ -3076,7 +3074,7 @@ namespace hp // Create sufficiently many // hp::DoFLevels. while (levels.size () < tria->n_levels ()) - levels.push_back (new dealii::internal::hp::DoFLevel); + levels.push_back (new internal::hp::DoFLevel); // then make sure that on each // level we have the appropriate @@ -3195,7 +3193,6 @@ namespace hp } - template <> void DoFHandler<1,3>::pre_refinement_action () { @@ -3235,7 +3232,7 @@ namespace hp // it is appended to the DoFHandler // levels. if (levels.size () < tria->n_levels ()) - levels.push_back (new dealii::internal::hp::DoFLevel); + levels.push_back (new internal::hp::DoFLevel); // Coarsening can lead to the loss // of levels. Hence remove them. @@ -3310,32 +3307,6 @@ namespace hp } - template - template - unsigned int - DoFHandler::get_dof_index (const unsigned int, - const unsigned int, - const unsigned int, - const unsigned int) const - { - Assert (false, ExcNotImplemented()); - return numbers::invalid_unsigned_int; - } - - - template - template - void - DoFHandler::set_dof_index (const unsigned int, - const unsigned int, - const unsigned int, - const unsigned int, - const unsigned int) const - { - Assert (false, ExcNotImplemented()); - } - - template void DoFHandler::clear_space () { -- 2.39.5