From ada5b87def3c320f91209f36f875fa5fbe900ebe Mon Sep 17 00:00:00 2001 From: Spencer Patty Date: Thu, 4 Feb 2016 22:42:10 -0600 Subject: [PATCH] rerun the indent styling to be back in the proper indentation style --- include/deal.II/grid/grid_tools.h | 10 +++++----- source/grid/grid_tools.cc | 14 +++++++------- 2 files changed, 12 insertions(+), 12 deletions(-) diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index f51b4b9041..1dc398aff2 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -1093,15 +1093,15 @@ namespace GridTools * appropriately. * * It is necessary that the finite element underlying the MeshType used has - * degrees of freedom that are logically associated to a vertex, line, quad, + * degrees of freedom that are logically associated to a vertex, line, quad, * or hex. This includes both nodal degrees of freedom and other modal types - * of dofs that are associated to an edge, etc. The result is the patch of - * cells representing the support of the basis element associated to the + * of dofs that are associated to an edge, etc. The result is the patch of + * cells representing the support of the basis element associated to the * degree of freedom. For instance using an FE_Q finite element, we obtain - * the standard patch of cells touching the degree of freedom and then others + * the standard patch of cells touching the degree of freedom and then others * that take care of possible hanging node constraints. Using a FE_DGQ finite * element, the degrees of freedom are logically considered to be "interior" to - * the cells so the patch would be the cell on which the degree of freedom is + * the cells so the patch would be the cell on which the degree of freedom is * located. * * @tparam MeshType The MeshType should be a DoFHandler or hp::DoFHandler. diff --git a/source/grid/grid_tools.cc b/source/grid/grid_tools.cc index 508867e6bb..6f4e101f33 100644 --- a/source/grid/grid_tools.cc +++ b/source/grid/grid_tools.cc @@ -3113,7 +3113,7 @@ next_cell: // be added on account of adaptivity hanging node // constraints. typename MeshType::active_cell_iterator cell = dof_handler.begin_active(), - endc = dof_handler.end(); + endc = dof_handler.end(); for (; cell!=endc; ++cell) { // Need to loop through all cells that could @@ -3283,12 +3283,12 @@ next_cell: if (MeshType::dimension == 3) - { - // finally, restore user flags that were changed above - // to when we constructed the pointers to parent of lines - // Since dof_handler is const, we must leave it unchanged. - const_cast &>(dof_handler.get_triangulation()).load_user_flags (user_flags); - } + { + // finally, restore user flags that were changed above + // to when we constructed the pointers to parent of lines + // Since dof_handler is const, we must leave it unchanged. + const_cast &>(dof_handler.get_triangulation()).load_user_flags (user_flags); + } // Finally, we copy map of sets to // map of vectors using assign() -- 2.39.5