qpoint < fe_interface_values.n_quadrature_points;
++qpoint)
{
- const double jump =
- coeff1 * grad_u[0][qpoint] * fe_interface_values.normal(qpoint) -
- coeff2 * grad_u[1][qpoint] * fe_interface_values.normal(qpoint);
+ const double jump = coeff1 * grad_u[0][qpoint] *
+ fe_interface_values.normal_vector(qpoint) -
+ coeff2 * grad_u[1][qpoint] *
+ fe_interface_values.normal_vector(qpoint);
jump_norm_square += jump * jump * fe_interface_values.JxW(qpoint);
}
const std::vector<double> &
get_JxW_values() const;
+ /**
+ * Return the normal in a given quadrature point.
+ *
+ * The normal points in outwards direction as seen from the first cell of
+ * this interface.
+ *
+ * @dealiiRequiresUpdateFlags{update_normal_vectors}
+ */
+ DEAL_II_DEPRECATED_EARLY_WITH_COMMENT("Use the function normal_vector().")
+ Tensor<1, spacedim>
+ normal(const unsigned int q_point_index) const;
+
+ /**
+ * Return the normal in a given quadrature point.
+ *
+ * The normal points in outwards direction as seen from the first cell of
+ * this interface.
+ *
+ * @dealiiRequiresUpdateFlags{update_normal_vectors}
+ */
+ Tensor<1, spacedim>
+ normal_vector(const unsigned int q_point_index) const;
+
/**
* Return the normal vector of the interface in each quadrature point.
*
std_cxx20::ranges::iota_view<unsigned int, unsigned int>
quadrature_point_indices() const;
+ /**
+ * Return the location of the <tt>q_point</tt>th quadrature point in
+ * real space.
+ *
+ * @dealiiRequiresUpdateFlags{update_quadrature_points}
+ */
+ const Point<spacedim> &
+ quadrature_point(const unsigned int q_point) const;
+
/**
* Return a reference to the quadrature points in real space.
*
std::array<unsigned int, 2>
interface_dof_to_dof_indices(const unsigned int interface_dof_index) const;
- /**
- * Return the normal in a given quadrature point.
- *
- * The normal points in outwards direction as seen from the first cell of
- * this interface.
- *
- * @dealiiRequiresUpdateFlags{update_normal_vectors}
- */
- Tensor<1, spacedim>
- normal(const unsigned int q_point_index) const;
-
/**
* @}
*/
+template <int dim, int spacedim>
+const Point<spacedim> &
+FEInterfaceValues<dim, spacedim>::quadrature_point(
+ const unsigned int q_point) const
+{
+ Assert(fe_face_values != nullptr,
+ ExcMessage("This call requires a call to reinit() first."));
+ return fe_face_values->quadrature_point(q_point);
+}
+
+
+
template <int dim, int spacedim>
const std::vector<Point<spacedim>> &
FEInterfaceValues<dim, spacedim>::get_quadrature_points() const
template <int dim, int spacedim>
Tensor<1, spacedim>
FEInterfaceValues<dim, spacedim>::normal(const unsigned int q_point_index) const
+{
+ return normal_vector(q_point_index);
+}
+
+
+
+template <int dim, int spacedim>
+Tensor<1, spacedim>
+FEInterfaceValues<dim, spacedim>::normal_vector(
+ const unsigned int q_point_index) const
{
return fe_face_values->normal_vector(q_point_index);
}