From 81311fb56738848a491c894168cde29d4f1cece5 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Wed, 4 Feb 2015 21:34:54 -0600 Subject: [PATCH] Reindent. --- include/deal.II/dofs/dof_renumbering.h | 2 +- include/deal.II/numerics/vector_tools.templates.h | 14 +++++++------- source/grid/manifold_lib.cc | 2 +- source/grid/tria_accessor.cc | 2 +- source/grid/tria_boundary_lib.cc | 2 +- 5 files changed, 11 insertions(+), 11 deletions(-) diff --git a/include/deal.II/dofs/dof_renumbering.h b/include/deal.II/dofs/dof_renumbering.h index 44acdadf01..74dc7ddbe9 100644 --- a/include/deal.II/dofs/dof_renumbering.h +++ b/include/deal.II/dofs/dof_renumbering.h @@ -406,7 +406,7 @@ namespace DoFRenumbering }; - + /** * A namespace for the implementation of some renumbering algorithms based * on algorithms implemented in the Boost Graph Library (BGL) by Jeremy Siek diff --git a/include/deal.II/numerics/vector_tools.templates.h b/include/deal.II/numerics/vector_tools.templates.h index f17e052909..d5db44f78f 100644 --- a/include/deal.II/numerics/vector_tools.templates.h +++ b/include/deal.II/numerics/vector_tools.templates.h @@ -2977,15 +2977,15 @@ namespace VectorTools || ((dynamic_cast*> (&fe) != 0) && (line * fe.degree <= i) && (i < (line + 1) * fe.degree))) { - const double tangential_solution_component - = (values[q_point] (first_vector_component) * tangentials[q_point][0] - + values[q_point] (first_vector_component + 1) * tangentials[q_point][1] - + values[q_point] (first_vector_component + 2) * tangentials[q_point][2]); + const double tangential_solution_component + = (values[q_point] (first_vector_component) * tangentials[q_point][0] + + values[q_point] (first_vector_component + 1) * tangentials[q_point][1] + + values[q_point] (first_vector_component + 2) * tangentials[q_point][2]); dof_values[i] += (fe_values.JxW (q_point) * tangential_solution_component * (fe_values[vec].value (fe.face_to_cell_index (i, face), q_point) * - tangentials[q_point]) + tangentials[q_point]) / std::sqrt (jacobians[q_point][0][edge_coordinate_direction[face][line]] * jacobians[q_point][0][edge_coordinate_direction[face][line]] + jacobians[q_point][1][edge_coordinate_direction[face][line]] @@ -3122,7 +3122,7 @@ namespace VectorTools shifted_reference_point_2)) / tol; tangentials[q_point] /= tangentials[q_point].norm(); - + // Compute the degrees // of freedom. for (unsigned int i = 0; i < fe.dofs_per_face; ++i) @@ -4473,7 +4473,7 @@ namespace VectorTools Tensor<1,dim> normal_vector = (cell->face(face_no)->get_boundary().normal_vector (cell->face(face_no), - fe_values.quadrature_point(i))); + fe_values.quadrature_point(i))); if (normal_vector * static_cast >(fe_values.normal_vector(i)) < 0) normal_vector *= -1; Assert (std::fabs(normal_vector.norm() - 1) < 1e-14, diff --git a/source/grid/manifold_lib.cc b/source/grid/manifold_lib.cc index 5039586936..534fdfd7a8 100644 --- a/source/grid/manifold_lib.cc +++ b/source/grid/manifold_lib.cc @@ -185,7 +185,7 @@ get_new_point (const Quadrature &quad) const // the axis. to this end, we have to take into account the offset // point_on_axis and the direction of the axis const Tensor<1,spacedim> vector_from_axis = (middle-point_on_axis) - - ((middle-point_on_axis) * direction) * direction; + ((middle-point_on_axis) * direction) * direction; // scale it to the desired length and put everything back together, // unless we have a point on the axis diff --git a/source/grid/tria_accessor.cc b/source/grid/tria_accessor.cc index e4253d5700..0da05a765f 100644 --- a/source/grid/tria_accessor.cc +++ b/source/grid/tria_accessor.cc @@ -1284,7 +1284,7 @@ bool CellAccessor<2>::point_inside (const Point<2> &p) const // vector from the first vertex // of the line to the point const Tensor<1,2> to_p = p-this->vertex( - GeometryInfo<2>::face_to_cell_vertices(f,0)); + GeometryInfo<2>::face_to_cell_vertices(f,0)); // vector describing the line const Tensor<1,2> face = direction[f]*( this->vertex(GeometryInfo<2>::face_to_cell_vertices(f,1)) - diff --git a/source/grid/tria_boundary_lib.cc b/source/grid/tria_boundary_lib.cc index 234803519e..04eb74fbd8 100644 --- a/source/grid/tria_boundary_lib.cc +++ b/source/grid/tria_boundary_lib.cc @@ -594,7 +594,7 @@ HyperBallBoundary::get_intermediate_points_between_points ( Assert(n>0, ExcInternalError()); const Tensor<1,spacedim> v0=p0-center, - v1=p1-center; + v1=p1-center; const double length=(v1-v0).norm(); double eps=1e-12; -- 2.39.5