From 8c4e947cf88303202cbb751892163ae65c4649f1 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Mon, 13 Mar 2017 18:46:45 -0600 Subject: [PATCH] Use FE::convert_generalized_support_point_values_to_nodal_values(). --- include/deal.II/fe/fe_tools.h | 5 +++-- source/fe/fe_tools.cc | 11 ++++++----- 2 files changed, 9 insertions(+), 7 deletions(-) diff --git a/include/deal.II/fe/fe_tools.h b/include/deal.II/fe/fe_tools.h index e1b50ecebe..b4f8a0270b 100644 --- a/include/deal.II/fe/fe_tools.h +++ b/include/deal.II/fe/fe_tools.h @@ -234,7 +234,7 @@ namespace FETools /** * This is a rather specialized function used during the construction of * finite element objects. It is used to build the basis of shape functions - * for an element given a set of polynomials and interpolation points. The + * for an element, given a set of polynomials and interpolation points. The * function is only implemented for finite elements with exactly @p dim * vector components. In particular, this applies to classes derived from * the FE_PolyTensor class. @@ -291,7 +291,8 @@ namespace FETools * that returns a scalar. * - That the finite element has exactly @p dim vector components. * - That the function $f_j$ is given by whatever the element implements - * through the FiniteElement::interpolate() function. + * through the FiniteElement::convert_generalized_support_point_values_to_nodal_values() + * function. * * @param fe The finite element for which the operations above are to be * performed. diff --git a/source/fe/fe_tools.cc b/source/fe/fe_tools.cc index 03b75d8367..438fa43bdc 100644 --- a/source/fe/fe_tools.cc +++ b/source/fe/fe_tools.cc @@ -1627,8 +1627,8 @@ namespace FETools // We need the values of the polynomials in all generalized support points. // This function specifically works for the case where shape functions // have 'dim' vector components, so allocate that much space - std::vector > - values (dim, std::vector(points.size())); + std::vector > + values (points.size(), Vector(dim)); // In this vector, we store the // result of the interpolation @@ -1645,11 +1645,12 @@ namespace FETools for (unsigned int k=0; k