]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Reindent.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 5 Feb 2015 03:34:54 +0000 (21:34 -0600)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 5 Feb 2015 03:34:54 +0000 (21:34 -0600)
include/deal.II/dofs/dof_renumbering.h
include/deal.II/numerics/vector_tools.templates.h
source/grid/manifold_lib.cc
source/grid/tria_accessor.cc
source/grid/tria_boundary_lib.cc

index 44acdadf0171701d903c4841ce76f63fd1b25c02..74dc7ddbe900b57631d9b2ee552d553f42d3a39f 100644 (file)
@@ -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
index f17e052909be24811a23a122a022f36725063125..d5db44f78f745ca5cfc1c20e8521788e6f178dcf 100644 (file)
@@ -2977,15 +2977,15 @@ namespace VectorTools
                 || ((dynamic_cast<const FE_Nedelec<dim>*> (&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<Tensor<1,dim> >(fe_values.normal_vector(i)) < 0)
                       normal_vector *= -1;
                     Assert (std::fabs(normal_vector.norm() - 1) < 1e-14,
index 5039586936b699479d1cd8319164601347adc891..534fdfd7a80951225dd5f4cc1b141757034ef3e0 100644 (file)
@@ -185,7 +185,7 @@ get_new_point (const Quadrature<spacedim> &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
index e4253d5700e1eea7b7ee1c4bd4c0c3d1d45df875..0da05a765f67a3613f1d216ef0e17e611728fe7a 100644 (file)
@@ -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)) -
index 234803519e7b0248364554a3db0aaa987e2b5b8f..04eb74fbd8c965a7d76c2a4eba98e82449637b26 100644 (file)
@@ -594,7 +594,7 @@ HyperBallBoundary<dim,spacedim>::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;

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.