From 4d265e3a190b44444225a6210305ace024379e3d Mon Sep 17 00:00:00 2001 From: Martin Kronbichler Date: Wed, 25 Aug 2010 13:47:24 +0000 Subject: [PATCH] Indent, make compile again. git-svn-id: https://svn.dealii.org/trunk@21703 0785d39b-7218-0410-832d-ea1e28bc413d --- .../include/multigrid/mg_constraints.h | 2 + deal.II/deal.II/source/dofs/dof_tools.cc | 206 +++++++++--------- 2 files changed, 105 insertions(+), 103 deletions(-) diff --git a/deal.II/deal.II/include/multigrid/mg_constraints.h b/deal.II/deal.II/include/multigrid/mg_constraints.h index 12b7f30ee9..4c9c8e798d 100644 --- a/deal.II/deal.II/include/multigrid/mg_constraints.h +++ b/deal.II/deal.II/include/multigrid/mg_constraints.h @@ -30,6 +30,8 @@ template class FunctionMap; /** * Collection of boundary constraints and refinement edge constraints * for level vectors. + * + * @ingroup mg */ class MGConstraints : public Subscriptor { diff --git a/deal.II/deal.II/source/dofs/dof_tools.cc b/deal.II/deal.II/source/dofs/dof_tools.cc index e5d885fca3..a41638dba0 100644 --- a/deal.II/deal.II/source/dofs/dof_tools.cc +++ b/deal.II/deal.II/source/dofs/dof_tools.cc @@ -502,132 +502,132 @@ void DoFTools::make_boundary_sparsity_pattern ( #if deal_II_dimension != 1 template void -DoFTools::make_flux_sparsity_pattern ( - const DH &dof, - SparsityPattern &sparsity, - const ConstraintMatrix &constraints, - const bool keep_constrained_dofs, - const unsigned int subdomain_id) +DoFTools::make_flux_sparsity_pattern (const DH &dof, + SparsityPattern &sparsity, + const ConstraintMatrix &constraints, + const bool keep_constrained_dofs, + const unsigned int subdomain_id) { const unsigned int n_dofs = dof.n_dofs(); - Assert (sparsity.n_rows() == n_dofs, -ExcDimensionMismatch (sparsity.n_rows(), n_dofs)); - Assert (sparsity.n_cols() == n_dofs, -ExcDimensionMismatch (sparsity.n_cols(), n_dofs)); + AssertDimension (sparsity.n_rows(), n_dofs); + AssertDimension (sparsity.n_cols(), n_dofs); std::vector dofs_on_this_cell; std::vector dofs_on_other_cell; dofs_on_this_cell.reserve (max_dofs_per_cell(dof)); dofs_on_other_cell.reserve (max_dofs_per_cell(dof)); typename DH::active_cell_iterator cell = dof.begin_active(), - endc = dof.end(); -// Clear user flags because we will -// need them. But first we save -// them and make sure that we -// restore them later such that at -// the end of this function the -// Triangulation will be in the -// same state as it was at the -// beginning of this function. + endc = dof.end(); + + // Clear user flags because we will + // need them. But first we save them + // and make sure that we restore them + // later such that at the end of this + // function the Triangulation will be + // in the same state as it was at the + // beginning of this function. std::vector user_flags; dof.get_tria().save_user_flags(user_flags); const_cast &>(dof.get_tria()).clear_user_flags (); - // In case we work with a distributed - // sparsity pattern of Trilinos type, we - // only have to do the work if the - // current cell is owned by the calling - // processor. Otherwise, just continue. + + // In case we work with a distributed + // sparsity pattern of Trilinos type, we + // only have to do the work if the + // current cell is owned by the calling + // processor. Otherwise, just continue. for (; cell!=endc; ++cell) -// if ((subdomain_id == numbers::invalid_unsigned_int) -//>-----|| -//>-----(subdomain_id == cell->subdomain_id())) + // if ((subdomain_id == numbers::invalid_unsigned_int) + // || + // (subdomain_id == cell->subdomain_id())) { const unsigned int n_dofs_on_this_cell = cell->get_fe().dofs_per_cell; dofs_on_this_cell.resize (n_dofs_on_this_cell); cell->get_dof_indices (dofs_on_this_cell); ->------->------->------->------- // make sparsity pattern for this cell -// for (unsigned int i=0; i-----for (unsigned int j=0; j----- sparsity.add (dofs_on_this_cell[i], -//>----->------->-------dofs_on_this_cell[j]); - // make sparsity pattern for this - // cell. if no constraints pattern was - // given, then the following call acts - // as if simply no constraints existed -constraints.add_entries_local_to_global (dofs_on_this_cell, -sparsity, -keep_constrained_dofs); - - // Loop over all interior neighbors + + // make sparsity pattern for this cell + // for (unsigned int i=0; i::faces_per_cell; - ++face) -{ - typename DH::face_iterator cell_face = cell->face(face); - if (cell_face->user_flag_set ()) - continue; - if (! cell_face->at_boundary() ) - { - typename DH::cell_iterator neighbor = cell->neighbor(face); + face < GeometryInfo::faces_per_cell; + ++face) + { + typename DH::face_iterator cell_face = cell->face(face); + if (cell_face->user_flag_set ()) + continue; + if (! cell_face->at_boundary() ) + { + typename DH::cell_iterator neighbor = cell->neighbor(face); - const unsigned int neighbor_face - = cell->neighbor_face_no(face); + const unsigned int neighbor_face + = cell->neighbor_face_no(face); - if (cell_face->has_children()) -{ - for (unsigned int sub_nr = 0; - sub_nr != cell_face->number_of_children(); - ++sub_nr) - { - const typename DH::cell_iterator - sub_neighbor -= cell->neighbor_child_on_subface (face, sub_nr); + if (cell_face->has_children()) + { + for (unsigned int sub_nr = 0; + sub_nr != cell_face->number_of_children(); + ++sub_nr) + { + const typename DH::cell_iterator + sub_neighbor + = cell->neighbor_child_on_subface (face, sub_nr); - const unsigned int n_dofs_on_neighbor - = sub_neighbor->get_fe().dofs_per_cell; - dofs_on_other_cell.resize (n_dofs_on_neighbor); - sub_neighbor->get_dof_indices (dofs_on_other_cell); + const unsigned int n_dofs_on_neighbor + = sub_neighbor->get_fe().dofs_per_cell; + dofs_on_other_cell.resize (n_dofs_on_neighbor); + sub_neighbor->get_dof_indices (dofs_on_other_cell); - for (unsigned int i=0; iface(neighbor_face)->set_user_flag (); - } -} - else - { -// Refinement edges are -// taken care of by -// coarser cells - if (cell->neighbor_is_coarser(face)) - continue; - - const unsigned int n_dofs_on_neighbor - = neighbor->get_fe().dofs_per_cell; - dofs_on_other_cell.resize (n_dofs_on_neighbor); - - neighbor->get_dof_indices (dofs_on_other_cell); - - for (unsigned int i=0; iface(neighbor_face)->set_user_flag (); -} - } -} + for (unsigned int i=0; iface(neighbor_face)->set_user_flag (); + } + } + else + { + // Refinement edges are taken care of + // by coarser cells + if (cell->neighbor_is_coarser(face)) + continue; + + const unsigned int n_dofs_on_neighbor + = neighbor->get_fe().dofs_per_cell; + dofs_on_other_cell.resize (n_dofs_on_neighbor); + + neighbor->get_dof_indices (dofs_on_other_cell); + + for (unsigned int i=0; iface(neighbor_face)->set_user_flag (); + } + } + } } -// finally restore the user flags + + // finally restore the user flags const_cast &>(dof.get_tria()).load_user_flags(user_flags); } -- 2.39.5