From: Matthias Maier Date: Fri, 25 Sep 2015 22:12:08 +0000 (-0500) Subject: tensor.h: Rename cross_product to cross_product_2d/3d X-Git-Tag: v8.4.0-rc2~366^2~4 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=8524de224cb40b2d754447cdfcb44c82bd887700;p=dealii.git tensor.h: Rename cross_product to cross_product_2d/3d --- diff --git a/include/deal.II/base/tensor.h b/include/deal.II/base/tensor.h index 1e62926f51..4fbac9328c 100644 --- a/include/deal.II/base/tensor.h +++ b/include/deal.II/base/tensor.h @@ -1720,7 +1720,7 @@ outer_product(const Tensor &src1, template inline Tensor<1,dim,Number> -cross_product (const Tensor<1,dim,Number> &src) +cross_product_2d (const Tensor<1,dim,Number> &src) { Assert (dim==2, ExcInternalError()); @@ -1746,8 +1746,8 @@ cross_product (const Tensor<1,dim,Number> &src) template inline Tensor<1,dim,Number> -cross_product (const Tensor<1,dim,Number> &src1, - const Tensor<1,dim,Number> &src2) +cross_product_3d (const Tensor<1,dim,Number> &src1, + const Tensor<1,dim,Number> &src2) { Assert (dim==3, ExcInternalError()); diff --git a/include/deal.II/numerics/vector_tools.templates.h b/include/deal.II/numerics/vector_tools.templates.h index 99c45a06b7..b02808c9dd 100644 --- a/include/deal.II/numerics/vector_tools.templates.h +++ b/include/deal.II/numerics/vector_tools.templates.h @@ -2875,8 +2875,8 @@ namespace VectorTools // now compute the // two normals - orthonormals[0] = cross_product (vector, tmp); - orthonormals[1] = cross_product (vector, orthonormals[0]); + orthonormals[0] = cross_product_3d (vector, tmp); + orthonormals[1] = cross_product_3d (vector, orthonormals[0]); break; } @@ -4205,7 +4205,7 @@ namespace VectorTools // The RHS entries are: // \int_{edge} (tangential* boundary_value) * (tangential * edge_shape_function_i) dS. // - // In 2D, tangential*vector is equivalent to cross_product(normal, vector), so we use this instead. + // In 2D, tangential*vector is equivalent to cross_product_3d(normal, vector), so we use this instead. // This avoids possible issues with the computation of the tangent. // Store the normal at this quad point: @@ -4395,22 +4395,22 @@ namespace VectorTools const unsigned int cell_j = fe.face_to_cell_index (j_face_idx, face); cross_product_j = - cross_product(normal_vector, - fe_face_values[vec].value(cell_j, q_point)); + cross_product_3d(normal_vector, + fe_face_values[vec].value(cell_j, q_point)); for (unsigned int i = 0; i < associated_face_dofs; ++i) { const unsigned int i_face_idx = associated_face_dof_to_face_dof[i]; const unsigned int cell_i = fe.face_to_cell_index (i_face_idx, face); cross_product_i = - cross_product(normal_vector, - fe_face_values[vec].value(cell_i, q_point)); + cross_product_3d(normal_vector, + fe_face_values[vec].value(cell_i, q_point)); face_matrix(i, j) += fe_face_values.JxW(q_point) * cross_product_i * cross_product_j; } // compute rhs - cross_product_rhs = cross_product(normal_vector, tmp); + cross_product_rhs = cross_product_3d(normal_vector, tmp); face_rhs(j) += fe_face_values.JxW(q_point) * cross_product_rhs * cross_product_j; } @@ -5719,7 +5719,7 @@ namespace VectorTools // we get here only for dim==3, but at least one isn't // quite smart enough to notice this and warns when // compiling the function in 2d - tangent = cross_product (normals[0], normals[dim-2]); + tangent = cross_product_3d (normals[0], normals[dim-2]); break; default: Assert (false, ExcNotImplemented()); diff --git a/source/base/geometry_info.cc b/source/base/geometry_info.cc index 513baa8edc..8d7b354735 100644 --- a/source/base/geometry_info.cc +++ b/source/base/geometry_info.cc @@ -1820,7 +1820,7 @@ namespace internal Tensor<1,3> wedge_product (const Tensor<1,3> (&derivative)[2]) { - return cross_product (derivative[0], derivative[1]); + return cross_product_3d (derivative[0], derivative[1]); } diff --git a/source/fe/mapping_fe_field.cc b/source/fe/mapping_fe_field.cc index 8460d67c5e..5db7f7227d 100644 --- a/source/fe/mapping_fe_field.cc +++ b/source/fe/mapping_fe_field.cc @@ -1043,11 +1043,11 @@ namespace internal -1 : +1); break; case 2: - output_data.boundary_forms[i] = cross_product(data.aux[0][i]); + output_data.boundary_forms[i] = cross_product_2d(data.aux[0][i]); break; case 3: output_data.boundary_forms[i] = - cross_product(data.aux[0][i], data.aux[1][i]); + cross_product_3d(data.aux[0][i], data.aux[1][i]); break; default: Assert(false, ExcNotImplemented()); @@ -1080,13 +1080,13 @@ namespace internal data.contravariant[point].transpose(); Tensor<1, spacedim> cell_normal = - cross_product(DX_t[0], DX_t[1]); + cross_product_3d(DX_t[0], DX_t[1]); cell_normal /= cell_normal.norm(); // then compute the face normal from the face tangent // and the cell normal: output_data.boundary_forms[point] = - cross_product(data.aux[0][point], cell_normal); + cross_product_3d(data.aux[0][point], cell_normal); } } @@ -1293,10 +1293,10 @@ fill_fe_values (const typename Triangulation::cell_iterator &cell, if (dim==1) output_data.normal_vectors[point] = - cross_product(-DX_t[0]); + cross_product_2d(-DX_t[0]); else //dim == 2 output_data.normal_vectors[point] = - cross_product(DX_t[0], DX_t[1]); + cross_product_3d(DX_t[0], DX_t[1]); output_data.normal_vectors[point] /= output_data.normal_vectors[point].norm(); diff --git a/source/fe/mapping_q_generic.cc b/source/fe/mapping_q_generic.cc index 8f9ffd3e6b..eecbed9988 100644 --- a/source/fe/mapping_q_generic.cc +++ b/source/fe/mapping_q_generic.cc @@ -2102,10 +2102,10 @@ fill_fe_values (const typename Triangulation::cell_iterator &cell, if (dim==1) output_data.normal_vectors[point] = - cross_product(-DX_t[0]); + cross_product_2d(-DX_t[0]); else //dim == 2 output_data.normal_vectors[point] = - cross_product(DX_t[0], DX_t[1]); + cross_product_3d(DX_t[0], DX_t[1]); output_data.normal_vectors[point] /= output_data.normal_vectors[point].norm(); @@ -2246,11 +2246,11 @@ namespace internal break; case 2: output_data.boundary_forms[i] = - cross_product(data.aux[0][i]); + cross_product_2d(data.aux[0][i]); break; case 3: output_data.boundary_forms[i] = - cross_product(data.aux[0][i], data.aux[1][i]); + cross_product_3d(data.aux[0][i], data.aux[1][i]); break; default: Assert(false, ExcNotImplemented()); @@ -2282,13 +2282,13 @@ namespace internal data.contravariant[point].transpose(); Tensor<1, spacedim> cell_normal = - cross_product(DX_t[0], DX_t[1]); + cross_product_3d(DX_t[0], DX_t[1]); cell_normal /= cell_normal.norm(); // then compute the face normal from the face tangent // and the cell normal: output_data.boundary_forms[point] = - cross_product(data.aux[0][point], cell_normal); + cross_product_3d(data.aux[0][point], cell_normal); } } } diff --git a/source/grid/tria_accessor.cc b/source/grid/tria_accessor.cc index 361924f548..bb7f9ba438 100644 --- a/source/grid/tria_accessor.cc +++ b/source/grid/tria_accessor.cc @@ -981,7 +981,7 @@ namespace const Tensor<1,3> v01 = accessor.vertex(1) - accessor.vertex(0); const Tensor<1,3> v02 = accessor.vertex(2) - accessor.vertex(0); - Tensor<1,3> normal = cross_product(v01, v02); + Tensor<1,3> normal = cross_product_3d(v01, v02); const Tensor<1,3> v03 = accessor.vertex(3) - accessor.vertex(0); @@ -1003,7 +1003,7 @@ namespace // the face is planar. then its area is 1/2 of the norm of the // cross product of the two diagonals const Tensor<1,3> v12 = accessor.vertex(2) - accessor.vertex(1); - Tensor<1,3> twice_area = cross_product(v03, v12); + Tensor<1,3> twice_area = cross_product_3d(v03, v12); return 0.5 * twice_area.norm(); } diff --git a/source/grid/tria_boundary.cc b/source/grid/tria_boundary.cc index 27336e9bbf..b1731fcc03 100644 --- a/source/grid/tria_boundary.cc +++ b/source/grid/tria_boundary.cc @@ -491,7 +491,7 @@ namespace internal Tensor<1,2> normalized_alternating_product (const Tensor<1,2> (&basis_vectors)[1]) { - Tensor<1,2> tmp = cross_product (basis_vectors[0]); + Tensor<1,2> tmp = cross_product_2d (basis_vectors[0]); return tmp/tmp.norm(); } @@ -512,7 +512,7 @@ namespace internal Tensor<1,3> normalized_alternating_product (const Tensor<1,3> (&basis_vectors)[2]) { - Tensor<1,3> tmp = cross_product (basis_vectors[0], basis_vectors[1]); + Tensor<1,3> tmp = cross_product_3d (basis_vectors[0], basis_vectors[1]); return tmp/tmp.norm(); } @@ -698,7 +698,7 @@ get_normals_at_vertices (const Triangulation<3>::face_iterator &face, // then compute the normal by taking the cross product. since the // normal is not required to be normalized, no problem here - face_vertex_normals[vertex] = cross_product(tangents[0], tangents[1]); + face_vertex_normals[vertex] = cross_product_3d(tangents[0], tangents[1]); }; }