From 4bf648bf6560151f4a6e5c35edf7395f14b5c87e Mon Sep 17 00:00:00 2001 From: Matthias Maier Date: Wed, 26 Nov 2014 23:34:04 +0100 Subject: [PATCH] make astyle happy --- include/deal.II/grid/grid_tools.h | 4 ++-- source/dofs/dof_tools_constraints.cc | 33 ++++++++++++++-------------- source/grid/grid_tools.cc | 6 +++-- 3 files changed, 23 insertions(+), 20 deletions(-) diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index d304ffbbc3..b13760d5be 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -1171,7 +1171,7 @@ namespace GridTools const FaceIterator &face2, const int direction, const Tensor<1,FaceIterator::AccessorType::space_dimension> &offset - = Tensor<1,FaceIterator::AccessorType::space_dimension>(), + = Tensor<1,FaceIterator::AccessorType::space_dimension>(), const FullMatrix &matrix = FullMatrix()); @@ -1184,7 +1184,7 @@ namespace GridTools const FaceIterator &face2, const int direction, const Tensor<2,FaceIterator::AccessorType::space_dimension> &offset - = Tensor<1,FaceIterator::AccessorType::space_dimension>(), + = Tensor<1,FaceIterator::AccessorType::space_dimension>(), const FullMatrix &matrix = FullMatrix()); diff --git a/source/dofs/dof_tools_constraints.cc b/source/dofs/dof_tools_constraints.cc index 3811a3433c..fdb01c9c73 100644 --- a/source/dofs/dof_tools_constraints.cc +++ b/source/dofs/dof_tools_constraints.cc @@ -2020,7 +2020,7 @@ namespace DoFTools { Assert(face_1->n_active_fe_indices() == 1, ExcInternalError()); const unsigned int n_dofs = - face_1->get_fe(face_1->nth_active_fe_index(0)).dofs_per_face; + face_1->get_fe(face_1->nth_active_fe_index(0)).dofs_per_face; Assert(matrix.m() == 0 || matrix.m() == n_dofs || matrix.m() == (int)spacedim, @@ -2032,7 +2032,7 @@ namespace DoFTools { Assert(face_2->n_active_fe_indices() == 1, ExcInternalError()); const unsigned int n_dofs = - face_2->get_fe(face_2->nth_active_fe_index(0)).dofs_per_face; + face_2->get_fe(face_2->nth_active_fe_index(0)).dofs_per_face; Assert(matrix.m() == 0 || matrix.m() == n_dofs || matrix.m() == (int)spacedim, @@ -2072,16 +2072,17 @@ namespace DoFTools if (face_1->has_children() && face_2->has_children()) { - // In the case that both faces have children, we loop over all - // children and apply make_periodicty_constrains recursively: + // In the case that both faces have children, we loop over all + // children and apply make_periodicty_constrains recursively: - Assert(face_1->n_children() == GeometryInfo::max_children_per_face && - face_2->n_children() == - GeometryInfo::max_children_per_face, - ExcNotImplemented()); + Assert(face_1->n_children() == GeometryInfo::max_children_per_face && + face_2->n_children() == + GeometryInfo::max_children_per_face, + ExcNotImplemented()); - for (unsigned int i = 0; i < GeometryInfo::max_children_per_face; - ++i) { + for (unsigned int i = 0; i < GeometryInfo::max_children_per_face; + ++i) + { // Lookup the index for the second face unsigned int j; switch (dim) @@ -2114,9 +2115,9 @@ namespace DoFTools // The finite element that matters is the one on the active face: const FiniteElement &fe = - face_1->has_children() - ? face_2->get_fe(face_2->nth_active_fe_index(0)) - : face_1->get_fe(face_1->nth_active_fe_index(0)); + face_1->has_children() + ? face_2->get_fe(face_2->nth_active_fe_index(0)) + : face_1->get_fe(face_1->nth_active_fe_index(0)); const unsigned int n_dofs = fe.dofs_per_face; @@ -2127,7 +2128,7 @@ namespace DoFTools return; const FullMatrix transformation = - compute_transformation(fe, matrix, first_vector_components); + compute_transformation(fe, matrix, first_vector_components); if (! face_2->has_children()) { @@ -2177,8 +2178,8 @@ namespace DoFTools component_mask, face_orientation, face_orientation - ? face_rotation ^ face_flip - : face_flip, + ? face_rotation ^ face_flip + : face_flip, face_rotation); } } diff --git a/source/grid/grid_tools.cc b/source/grid/grid_tools.cc index 0a5a0c8322..72a11fedef 100644 --- a/source/grid/grid_tools.cc +++ b/source/grid/grid_tools.cc @@ -2593,12 +2593,14 @@ next_cell: // We have a match, so insert the matching pairs and // remove the matched cell in pairs2 to speed up the // matching: - const PeriodicFacePair matched_face = { + const PeriodicFacePair matched_face = + { {cell1, cell2}, {face_idx1, face_idx2}, orientation, matrix, - first_vector_components}; + first_vector_components + }; matched_pairs.push_back(matched_face); pairs2.erase(it2); ++n_matches; -- 2.39.5