From c80839e6bcf35454aa10b69b8fd3130a615e0e34 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Fri, 9 Mar 2018 08:09:17 -0700 Subject: [PATCH] Improve documentation of FETools::compute_projection_matrices(). --- include/deal.II/fe/fe_tools.h | 24 ++++++++++++++---------- 1 file changed, 14 insertions(+), 10 deletions(-) diff --git a/include/deal.II/fe/fe_tools.h b/include/deal.II/fe/fe_tools.h index 4c2aabfc86..312e9663af 100644 --- a/include/deal.II/fe/fe_tools.h +++ b/include/deal.II/fe/fe_tools.h @@ -393,16 +393,20 @@ namespace FETools * FiniteElement classes in order to fill the respective * FiniteElement::restriction matrices. * - * @arg fe The finite element class for which we compute the projection - * matrices. @arg matrices A reference to - * RefinementCase::isotropic_refinement vectors of FullMatrix - * objects. Each vector corresponds to one RefinementCase @p refinement_case - * and is of the vector size - * GeometryInfo::n_children(refinement_case). This is the - * format used in FiniteElement, where we want to use this function mostly. - * - * @arg isotropic_only Set to true if you only want to compute - * matrices for isotropic refinement. + * @arg[in] fe The finite element class for which we compute the projection + * matrices. + * + * @arg[out] matrices A reference to a set of + * RefinementCase::isotropic_refinement vectors of FullMatrix + * objects. Each vector corresponds to one RefinementCase @p refinement_case + * and is of the vector size + * GeometryInfo::n_children(refinement_case). This is the + * format used in FiniteElement, where we want to use this function mostly. + * + * @arg[in] isotropic_only If set to true, then this + * function only computes data for the isotropic refinement case. The + * other elements of the output vector are left untouched (but still + * exist). */ template void compute_projection_matrices( -- 2.39.5