From 6ea19b3270354ba1666a87cacaadc1911d6cc6d7 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Wed, 4 Feb 2015 21:03:31 -0600 Subject: [PATCH] Fix up places where we use Point for directions when we should be using Tensor<1,dim>. --- source/grid/tria_boundary_lib.cc | 36 ++++++++++++++++---------------- 1 file changed, 18 insertions(+), 18 deletions(-) diff --git a/source/grid/tria_boundary_lib.cc b/source/grid/tria_boundary_lib.cc index 5eae3f2bce..234803519e 100644 --- a/source/grid/tria_boundary_lib.cc +++ b/source/grid/tria_boundary_lib.cc @@ -173,8 +173,8 @@ CylinderBoundary::get_intermediate_points_between_points ( const double x = line_points[i+1][0]; const Point middle = (1-x)*v0 + x*v1; - const Point vector_from_axis = (middle-point_on_axis) - - ((middle-point_on_axis) * direction) * direction; + const Tensor<1,spacedim> vector_from_axis = (middle-point_on_axis) - + ((middle-point_on_axis) * direction) * direction; if (vector_from_axis.norm() <= 1e-10 * middle.norm()) points[i] = middle; else @@ -252,8 +252,8 @@ get_normals_at_vertices (const typename Triangulation::face_iterat { const Point vertex = face->vertex(v); - const Point vector_from_axis = (vertex-point_on_axis) - - ((vertex-point_on_axis) * direction) * direction; + const Tensor<1,spacedim> vector_from_axis = (vertex-point_on_axis) - + ((vertex-point_on_axis) * direction) * direction; face_vertex_normals[v] = (vector_from_axis / vector_from_axis.norm()); } @@ -305,7 +305,7 @@ get_intermediate_points_between_points (const Point &p0, std::vector > &points) const { const unsigned int n = points.size (); - const Point axis = x_1 - x_0; + const Tensor<1,dim> axis = x_1 - x_0; Assert (n > 0, ExcInternalError ()); @@ -319,7 +319,7 @@ get_intermediate_points_between_points (const Point &p0, const Point x_i = (1-x)*p0 + x*p1; // To project this point on the boundary of the cone we first compute // the orthogonal projection of this point onto the axis of the cone. - const double c = (x_i - x_0) * axis / axis.square (); + const double c = (x_i - x_0) * axis / (axis*axis); const Point x_ip = x_0 + c * axis; // Compute the projection of the middle point on the boundary of the // cone. @@ -332,12 +332,12 @@ Point ConeBoundary:: get_new_point_on_line (const typename Triangulation::line_iterator &line) const { - const Point axis = x_1 - x_0; + const Tensor<1,dim> axis = x_1 - x_0; // Compute the middle point of the line. const Point middle = StraightBoundary::get_new_point_on_line (line); // To project it on the boundary of the cone we first compute the orthogonal // projection of the middle point onto the axis of the cone. - const double c = (middle - x_0) * axis / axis.square (); + const double c = (middle - x_0) * axis / (axis*axis); const Point middle_p = x_0 + c * axis; // Compute the projection of the middle point on the boundary of the cone. return middle_p + get_radius (middle_p) * (middle - middle_p) / (middle - middle_p).norm (); @@ -352,13 +352,13 @@ get_new_point_on_quad (const Triangulation<3>::quad_iterator &quad) const { const int dim = 3; - const Point axis = x_1 - x_0; + const Tensor<1,dim> axis = x_1 - x_0; // Compute the middle point of the quad. const Point middle = StraightBoundary<3,3>::get_new_point_on_quad (quad); // Same algorithm as above: To project it on the boundary of the cone we // first compute the orthogonal projection of the middle point onto the axis // of the cone. - const double c = (middle - x_0) * axis / axis.square (); + const double c = (middle - x_0) * axis / (axis*axis); const Point middle_p = x_0 + c * axis; // Compute the projection of the middle point on the boundary of the cone. return middle_p + get_radius (middle_p) * (middle - middle_p) / (middle - middle_p).norm (); @@ -458,13 +458,13 @@ ConeBoundary:: get_normals_at_vertices (const typename Triangulation::face_iterator &face, typename Boundary::FaceVertexNormals &face_vertex_normals) const { - const Point axis = x_1 - x_0; + const Tensor<1,dim> axis = x_1 - x_0; for (unsigned int vertex = 0; vertex < GeometryInfo::vertices_per_cell; ++vertex) { // Compute the orthogonal projection of the vertex onto the axis of the // cone. - const double c = (face->vertex (vertex) - x_0) * axis / axis.square (); + const double c = (face->vertex (vertex) - x_0) * axis / (axis*axis); const Point vertex_p = x_0 + c * axis; // Then compute the vector pointing from the point vertex_p on // the axis to the vertex. @@ -593,9 +593,9 @@ HyperBallBoundary::get_intermediate_points_between_points ( const unsigned int n=points.size(); Assert(n>0, ExcInternalError()); - const Point v0=p0-center, - v1=p1-center; - const double length=std::sqrt((v1-v0).square()); + const Tensor<1,spacedim> v0=p0-center, + v1=p1-center; + const double length=(v1-v0).norm(); double eps=1e-12; double r=0; @@ -609,10 +609,10 @@ HyperBallBoundary::get_intermediate_points_between_points ( const double r2=r*r; - Assert(std::fabs(v0.square()-r2) pm=0.5*(v0+v1); const double h=std::sqrt(pm.square()); -- 2.39.5