From 89392c8e51996065cd0ddda994c25bfbc906c813 Mon Sep 17 00:00:00 2001 From: Daniel Arndt Date: Sun, 12 Apr 2020 20:07:04 -0400 Subject: [PATCH] Don't copy from FEEvaluationAccess --- include/deal.II/matrix_free/fe_evaluation.h | 40 +++++++++++++++++---- 1 file changed, 34 insertions(+), 6 deletions(-) diff --git a/include/deal.II/matrix_free/fe_evaluation.h b/include/deal.II/matrix_free/fe_evaluation.h index b05a248881..838565b81a 100644 --- a/include/deal.II/matrix_free/fe_evaluation.h +++ b/include/deal.II/matrix_free/fe_evaluation.h @@ -467,25 +467,43 @@ public: // specialization of the base class, in this case FEEvaluationAccess. // For now, hack-in those functions manually only to fix documentation: - /** @copydoc FEEvaluationAccess::get_divergence() + /** + * Return the divergence of a vector-valued finite element at quadrature + * point number @p q_point after a call to @p evaluate(...,true,...). + * * @note Only available for n_components_==dim. */ VectorizedArrayType get_divergence(const unsigned int q_point) const; - /** @copydoc FEEvaluationAccess::get_symmetric_gradient() + /** + * Return the symmetric gradient of a vector-valued finite element at + * quadrature point number @p q_point after a call to @p + * evaluate(...,true,...). It corresponds to 0.5 + * (grad+gradT). + * * @note Only available for n_components_==dim. */ SymmetricTensor<2, dim, VectorizedArrayType> get_symmetric_gradient(const unsigned int q_point) const; - /** @copydoc FEEvaluationAccess::get_curl() + /** + * Return the curl of the vector field, $\nabla \times v$ after a call to @p + * evaluate(...,true,...). + * * @note Only available for n_components_==dim. */ Tensor<1, (dim == 2 ? 1 : dim), VectorizedArrayType> get_curl(const unsigned int q_point) const; - /** @copydoc FEEvaluationAccess::submit_divergence() + /** + * Write a contribution that is tested by the divergence to the field + * containing the values on quadrature points with component @p q_point. + * Access to the same field as through @p get_gradient. If applied before + * the function @p integrate(...,true) is called, this specifies what is + * tested by all basis function gradients on the current cell and integrated + * over. + * * @note Only available for n_components_==dim. * * @note This operation writes the data to the same field as @@ -497,7 +515,14 @@ public: submit_divergence(const VectorizedArrayType div_in, const unsigned int q_point); - /** @copydoc FEEvaluationAccess::submit_symmetric_gradient() + /** + * Write a contribution that is tested by the symmetric gradient to the field + * containing the values on quadrature points with component @p q_point. + * Access to the same field as through @p get_symmetric_gradient. If applied before + * the function @p integrate(...,true) is called, this specifies the + * symmetric gradient which is tested by all basis function symmetric + * gradients on the current cell and integrated over. + * * @note Only available for n_components_==dim. * * @note This operation writes the data to the same field as @@ -511,7 +536,10 @@ public: const SymmetricTensor<2, dim, VectorizedArrayType> grad_in, const unsigned int q_point); - /** @copydoc FEEvaluationAccess::submit_curl() + /** + * Write the components of a curl containing the values on quadrature point + * @p q_point. Access to the same data field as through @p get_gradient. + * * @note Only available for n_components_==dim. * * @note This operation writes the data to the same field as -- 2.39.5