|| ((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]]
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)
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,
// 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
// 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)) -