From: Luca Heltai Date: Tue, 15 Aug 2017 16:20:58 +0000 (-0600) Subject: Renamed convert_gen_sup_val_to_nodal_val to ..._dof_values X-Git-Tag: v9.0.0-rc1~1131^2~6 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=47db42867da730180e4cfbcf608bda7e68967902;p=dealii.git Renamed convert_gen_sup_val_to_nodal_val to ..._dof_values --- diff --git a/doc/doxygen/headers/glossary.h b/doc/doxygen/headers/glossary.h index 7a81a5d199..e035a08532 100644 --- a/doc/doxygen/headers/glossary.h +++ b/doc/doxygen/headers/glossary.h @@ -1345,7 +1345,7 @@ * code that describes a finite element simply by providing a polynomial * space (without having to give it any particular basis -- whatever is convenient * is entirely sufficient) and the nodal functionals. This is used, for example - * in the FiniteElement::convert_generalized_support_point_values_to_nodal_values() + * in the FiniteElement::convert_generalized_support_point_values_to_dof_values() * function. * * diff --git a/include/deal.II/fe/fe.h b/include/deal.II/fe/fe.h index 65558405ef..1639b565b3 100644 --- a/include/deal.II/fe/fe.h +++ b/include/deal.II/fe/fe.h @@ -2087,8 +2087,8 @@ public: */ virtual void - convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const; //@} diff --git a/include/deal.II/fe/fe_abf.h b/include/deal.II/fe/fe_abf.h index 8282708bd2..cc6e97cbf5 100644 --- a/include/deal.II/fe/fe_abf.h +++ b/include/deal.II/fe/fe_abf.h @@ -126,8 +126,8 @@ public: // documentation inherited from the base class virtual void - convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const; virtual std::size_t memory_consumption () const; diff --git a/include/deal.II/fe/fe_bdm.h b/include/deal.II/fe/fe_bdm.h index c95784f420..f1db2d0fdb 100644 --- a/include/deal.II/fe/fe_bdm.h +++ b/include/deal.II/fe/fe_bdm.h @@ -77,8 +77,8 @@ public: // documentation inherited from the base class virtual void - convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const; private: /** diff --git a/include/deal.II/fe/fe_dgq.h b/include/deal.II/fe/fe_dgq.h index 732197e017..d83f3a8544 100644 --- a/include/deal.II/fe/fe_dgq.h +++ b/include/deal.II/fe/fe_dgq.h @@ -309,8 +309,8 @@ public: */ virtual void - convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const; /** * Determine an estimate for the memory consumption (in bytes) of this @@ -426,8 +426,8 @@ public: */ virtual void - convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const; virtual std::unique_ptr > clone() const; diff --git a/include/deal.II/fe/fe_nedelec.h b/include/deal.II/fe/fe_nedelec.h index 1009c0e4b4..9c4398e4fd 100644 --- a/include/deal.II/fe/fe_nedelec.h +++ b/include/deal.II/fe/fe_nedelec.h @@ -258,8 +258,8 @@ public: // documentation inherited from the base class virtual void - convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const; /** * Return a list of constant modes of the element. diff --git a/include/deal.II/fe/fe_q.h b/include/deal.II/fe/fe_q.h index cc498f9fea..e41b0130b0 100644 --- a/include/deal.II/fe/fe_q.h +++ b/include/deal.II/fe/fe_q.h @@ -599,8 +599,8 @@ public: */ virtual void - convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const; }; diff --git a/include/deal.II/fe/fe_q_bubbles.h b/include/deal.II/fe/fe_q_bubbles.h index 18ae8c877b..25af8f5f14 100644 --- a/include/deal.II/fe/fe_q_bubbles.h +++ b/include/deal.II/fe/fe_q_bubbles.h @@ -107,8 +107,8 @@ public: // documentation inherited from the base class virtual void - convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const; /** * Return the matrix interpolating from the given finite element to the diff --git a/include/deal.II/fe/fe_q_dg0.h b/include/deal.II/fe/fe_q_dg0.h index 2667e50239..00c75b00d9 100644 --- a/include/deal.II/fe/fe_q_dg0.h +++ b/include/deal.II/fe/fe_q_dg0.h @@ -261,8 +261,8 @@ public: // documentation inherited from the base class virtual void - convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const; /** * Return the matrix interpolating from the given finite element to the diff --git a/include/deal.II/fe/fe_q_iso_q1.h b/include/deal.II/fe/fe_q_iso_q1.h index ec636809fb..158ebd26a9 100644 --- a/include/deal.II/fe/fe_q_iso_q1.h +++ b/include/deal.II/fe/fe_q_iso_q1.h @@ -138,8 +138,8 @@ public: */ virtual void - convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const; /** * @name Functions to support hp diff --git a/include/deal.II/fe/fe_rannacher_turek.h b/include/deal.II/fe/fe_rannacher_turek.h index 22b5e9b3a3..d903cea1c8 100644 --- a/include/deal.II/fe/fe_rannacher_turek.h +++ b/include/deal.II/fe/fe_rannacher_turek.h @@ -73,8 +73,8 @@ public: // documentation inherited from the base class virtual void - convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const; private: /** diff --git a/include/deal.II/fe/fe_raviart_thomas.h b/include/deal.II/fe/fe_raviart_thomas.h index 398f838595..f44c0d8c85 100644 --- a/include/deal.II/fe/fe_raviart_thomas.h +++ b/include/deal.II/fe/fe_raviart_thomas.h @@ -135,8 +135,8 @@ public: // documentation inherited from the base class virtual void - convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const; /** * Return a list of constant modes of the element. This method is currently @@ -264,8 +264,8 @@ public: virtual void - convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const; virtual void get_face_interpolation_matrix (const FiniteElement &source, FullMatrix &matrix) const; diff --git a/include/deal.II/fe/fe_system.h b/include/deal.II/fe/fe_system.h index 7ff99bbfb4..e439fb71b1 100644 --- a/include/deal.II/fe/fe_system.h +++ b/include/deal.II/fe/fe_system.h @@ -853,15 +853,15 @@ public: /** * Implementation of the - * FiniteElement::convert_generalized_support_point_values_to_nodal_values() + * FiniteElement::convert_generalized_support_point_values_to_dof_values() * function. The current function simply takes the input argument apart, * passes the pieces to the base elements, and then re-assembles everything * into the output argument. */ virtual void - convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const; /** * Determine an estimate for the memory consumption (in bytes) of this diff --git a/include/deal.II/fe/fe_tools.h b/include/deal.II/fe/fe_tools.h index 83c21001cd..8e8228eda1 100644 --- a/include/deal.II/fe/fe_tools.h +++ b/include/deal.II/fe/fe_tools.h @@ -291,7 +291,7 @@ 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::convert_generalized_support_point_values_to_nodal_values() + * through the FiniteElement::convert_generalized_support_point_values_to_dof_values() * function. * * @param fe The finite element for which the operations above are to be diff --git a/source/fe/fe.cc b/source/fe/fe.cc index c2e5179af8..901cdabf45 100644 --- a/source/fe/fe.cc +++ b/source/fe/fe.cc @@ -1098,8 +1098,8 @@ FiniteElement::get_constant_modes () const template void FiniteElement:: -convert_generalized_support_point_values_to_nodal_values (const std::vector > &, - std::vector &) const +convert_generalized_support_point_values_to_dof_values (const std::vector > &, + std::vector &) const { Assert (has_generalized_support_points(), ExcMessage ("The element for which you are calling the current " diff --git a/source/fe/fe_abf.cc b/source/fe/fe_abf.cc index 50f305295f..fa31e097ac 100644 --- a/source/fe/fe_abf.cc +++ b/source/fe/fe_abf.cc @@ -513,8 +513,8 @@ FE_ABF::has_support_on_face (const unsigned int shape_index, template void FE_ABF:: -convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const +convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const { Assert (support_point_values.size() == this->generalized_support_points.size(), ExcDimensionMismatch(support_point_values.size(), this->generalized_support_points.size())); diff --git a/source/fe/fe_bdm.cc b/source/fe/fe_bdm.cc index 48255014e6..dc3b08d956 100644 --- a/source/fe/fe_bdm.cc +++ b/source/fe/fe_bdm.cc @@ -126,8 +126,8 @@ FE_BDM::clone() const template void FE_BDM:: -convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const +convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const { Assert (support_point_values.size() == this->generalized_support_points.size(), ExcDimensionMismatch(support_point_values.size(), this->generalized_support_points.size())); diff --git a/source/fe/fe_dgq.cc b/source/fe/fe_dgq.cc index c61689604c..80c9c8ea99 100644 --- a/source/fe/fe_dgq.cc +++ b/source/fe/fe_dgq.cc @@ -115,8 +115,8 @@ FE_DGQ::get_name () const template void FE_DGQ:: -convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const +convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const { AssertDimension (support_point_values.size(), this->get_unit_support_points().size()); @@ -795,8 +795,8 @@ FE_DGQArbitraryNodes::get_name () const template void FE_DGQArbitraryNodes:: -convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const +convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const { AssertDimension (support_point_values.size(), this->get_unit_support_points().size()); diff --git a/source/fe/fe_nedelec.cc b/source/fe/fe_nedelec.cc index d3c5d7eea6..a13c5189bc 100644 --- a/source/fe/fe_nedelec.cc +++ b/source/fe/fe_nedelec.cc @@ -3099,8 +3099,8 @@ FE_Nedelec template void FE_Nedelec:: -convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const +convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const { const unsigned int deg = this->degree-1; Assert (support_point_values.size () == this->generalized_support_points.size (), diff --git a/source/fe/fe_q.cc b/source/fe/fe_q.cc index 714107825e..6d6e85436d 100644 --- a/source/fe/fe_q.cc +++ b/source/fe/fe_q.cc @@ -143,8 +143,8 @@ FE_Q::get_name () const template void FE_Q:: -convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const +convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const { AssertDimension (support_point_values.size(), this->get_unit_support_points().size()); diff --git a/source/fe/fe_q_bubbles.cc b/source/fe/fe_q_bubbles.cc index 4312fb0542..1cbac6c500 100644 --- a/source/fe/fe_q_bubbles.cc +++ b/source/fe/fe_q_bubbles.cc @@ -336,8 +336,8 @@ FE_Q_Bubbles::clone() const template void FE_Q_Bubbles:: -convert_generalized_support_point_values_to_nodal_values(const std::vector > &support_point_values, - std::vector &nodal_values) const +convert_generalized_support_point_values_to_dof_values(const std::vector > &support_point_values, + std::vector &nodal_values) const { Assert (support_point_values.size() == this->unit_support_points.size(), ExcDimensionMismatch(support_point_values.size(), diff --git a/source/fe/fe_q_dg0.cc b/source/fe/fe_q_dg0.cc index da353cc090..8139ad43f8 100644 --- a/source/fe/fe_q_dg0.cc +++ b/source/fe/fe_q_dg0.cc @@ -178,8 +178,8 @@ FE_Q_DG0::clone() const template void FE_Q_DG0:: -convert_generalized_support_point_values_to_nodal_values(const std::vector > &support_point_values, - std::vector &nodal_dofs) const +convert_generalized_support_point_values_to_dof_values(const std::vector > &support_point_values, + std::vector &nodal_dofs) const { Assert (support_point_values.size() == this->unit_support_points.size(), ExcDimensionMismatch(support_point_values.size(), diff --git a/source/fe/fe_q_iso_q1.cc b/source/fe/fe_q_iso_q1.cc index cbc1846276..d29980d725 100644 --- a/source/fe/fe_q_iso_q1.cc +++ b/source/fe/fe_q_iso_q1.cc @@ -72,8 +72,8 @@ FE_Q_iso_Q1::get_name () const template void FE_Q_iso_Q1:: -convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const +convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const { AssertDimension (support_point_values.size(), this->get_unit_support_points().size()); diff --git a/source/fe/fe_rannacher_turek.cc b/source/fe/fe_rannacher_turek.cc index 3c897f8286..0dd673b73b 100644 --- a/source/fe/fe_rannacher_turek.cc +++ b/source/fe/fe_rannacher_turek.cc @@ -106,8 +106,8 @@ void FE_RannacherTurek::initialize_support_points() template void FE_RannacherTurek:: -convert_generalized_support_point_values_to_nodal_values(const std::vector > &support_point_values, - std::vector &nodal_values) const +convert_generalized_support_point_values_to_dof_values(const std::vector > &support_point_values, + std::vector &nodal_values) const { AssertDimension(support_point_values.size(), this->generalized_support_points.size()); AssertDimension(nodal_values.size(), this->dofs_per_cell); diff --git a/source/fe/fe_raviart_thomas.cc b/source/fe/fe_raviart_thomas.cc index f24c03a00b..4e7a0ba180 100644 --- a/source/fe/fe_raviart_thomas.cc +++ b/source/fe/fe_raviart_thomas.cc @@ -465,8 +465,8 @@ FE_RaviartThomas::has_support_on_face ( template void FE_RaviartThomas:: -convert_generalized_support_point_values_to_nodal_values(const std::vector > &support_point_values, - std::vector &nodal_values) const +convert_generalized_support_point_values_to_dof_values(const std::vector > &support_point_values, + std::vector &nodal_values) const { Assert (support_point_values.size() == this->generalized_support_points.size(), ExcDimensionMismatch(support_point_values.size(), this->generalized_support_points.size())); diff --git a/source/fe/fe_raviart_thomas_nodal.cc b/source/fe/fe_raviart_thomas_nodal.cc index ff145a40b8..8c14fb9c8f 100644 --- a/source/fe/fe_raviart_thomas_nodal.cc +++ b/source/fe/fe_raviart_thomas_nodal.cc @@ -285,8 +285,8 @@ FE_RaviartThomasNodal::has_support_on_face ( template void FE_RaviartThomasNodal:: -convert_generalized_support_point_values_to_nodal_values(const std::vector > &support_point_values, - std::vector &nodal_values) const +convert_generalized_support_point_values_to_dof_values(const std::vector > &support_point_values, + std::vector &nodal_values) const { Assert (support_point_values.size() == this->generalized_support_points.size(), ExcDimensionMismatch(support_point_values.size(), this->generalized_support_points.size())); diff --git a/source/fe/fe_system.cc b/source/fe/fe_system.cc index 95dc9b5078..2f91a6e870 100644 --- a/source/fe/fe_system.cc +++ b/source/fe/fe_system.cc @@ -2251,8 +2251,8 @@ FESystem::get_constant_modes () const template void FESystem:: -convert_generalized_support_point_values_to_nodal_values (const std::vector > &support_point_values, - std::vector &nodal_values) const +convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, + std::vector &nodal_values) const { // we currently only support the case where each base element has exactly // as many generalized support points as there are dofs in that element. @@ -2301,7 +2301,7 @@ convert_generalized_support_point_values_to_nodal_values (const std::vector compare_values (fe.dofs_per_cell); - fe.convert_generalized_support_point_values_to_nodal_values(real_values, compare_values); + fe.convert_generalized_support_point_values_to_dof_values(real_values, compare_values); for (unsigned int i=0; i std::abs(dof_values[i])*1.e-6) diff --git a/tests/fe/fe_rannacher_turek_01.cc b/tests/fe/fe_rannacher_turek_01.cc index bf749e3f8b..aa8749d24d 100644 --- a/tests/fe/fe_rannacher_turek_01.cc +++ b/tests/fe/fe_rannacher_turek_01.cc @@ -68,7 +68,7 @@ void test_nodal_matrix() { for (unsigned int k = 0; k < values.size(); ++k) values[k][0] = fe.shape_value(i, points[k]); - fe.convert_generalized_support_point_values_to_nodal_values(values, local_dofs); + fe.convert_generalized_support_point_values_to_dof_values(values, local_dofs); for (unsigned int j=0; j < n_dofs; ++j) N(j,i) = local_dofs[j]; @@ -125,7 +125,7 @@ void test_interpolation() fev.get_function_values(input_vector, values); std::vector interpolated_local_dofs(n_dofs); - fe.convert_generalized_support_point_values_to_nodal_values(values, interpolated_local_dofs); + fe.convert_generalized_support_point_values_to_dof_values(values, interpolated_local_dofs); Vector local_dofs(n_dofs); cell->get_dof_values(input_vector, local_dofs); diff --git a/tests/fe/interpolate_q1.cc b/tests/fe/interpolate_q1.cc index 1a6a299a0c..0bebe3fe27 100644 --- a/tests/fe/interpolate_q1.cc +++ b/tests/fe/interpolate_q1.cc @@ -36,7 +36,7 @@ void check(const Function &f, std::vector > values (fe.get_unit_support_points().size(), Vector(1)); f.vector_value_list(fe.get_unit_support_points(), values); - fe.convert_generalized_support_point_values_to_nodal_values(values, dofs); + fe.convert_generalized_support_point_values_to_dof_values(values, dofs); deallog << " vector " << difference(fe,dofs,f) << std::endl; } @@ -52,7 +52,7 @@ void check_dg(const Function &f, std::vector > values (fe.get_unit_support_points().size(), Vector(1)); f.vector_value_list(fe.get_unit_support_points(), values); - fe.convert_generalized_support_point_values_to_nodal_values(values, dofs); + fe.convert_generalized_support_point_values_to_dof_values(values, dofs); deallog << " vector " << difference(fe,dofs,f) << std::endl; } @@ -69,7 +69,7 @@ void check_dg_lobatto(const Function &f, std::vector > values (fe.get_unit_support_points().size(), Vector(1)); f.vector_value_list(fe.get_unit_support_points(), values); - fe.convert_generalized_support_point_values_to_nodal_values(values, dofs); + fe.convert_generalized_support_point_values_to_dof_values(values, dofs); deallog << " vector " << difference(fe,dofs,f) << std::endl; } diff --git a/tests/fe/interpolate_q_bubbles.cc b/tests/fe/interpolate_q_bubbles.cc index 8ad2d12c10..7706f885d4 100644 --- a/tests/fe/interpolate_q_bubbles.cc +++ b/tests/fe/interpolate_q_bubbles.cc @@ -32,7 +32,7 @@ void check_q_bubbles(const Function &f, std::vector > values (fe.get_unit_support_points().size(), Vector(1)); f.vector_value_list(fe.get_unit_support_points(), values); - fe.convert_generalized_support_point_values_to_nodal_values(values, dofs); + fe.convert_generalized_support_point_values_to_dof_values(values, dofs); deallog << " value " << difference(fe,dofs,f) << std::endl; } diff --git a/tests/fe/interpolate_q_dg0.cc b/tests/fe/interpolate_q_dg0.cc index f3f5f8b0c0..b929fba839 100644 --- a/tests/fe/interpolate_q_dg0.cc +++ b/tests/fe/interpolate_q_dg0.cc @@ -32,7 +32,7 @@ void check_q_dg0(const Function &f, std::vector > values (fe.get_unit_support_points().size(), Vector(1)); f.vector_value_list(fe.get_unit_support_points(), values); - fe.convert_generalized_support_point_values_to_nodal_values(values, dofs); + fe.convert_generalized_support_point_values_to_dof_values(values, dofs); deallog << " vector " << difference(fe,dofs,f) << std::endl; } diff --git a/tests/fe/interpolate_q_iso_q1.cc b/tests/fe/interpolate_q_iso_q1.cc index 9d7231fbb7..3f14879b32 100644 --- a/tests/fe/interpolate_q_iso_q1.cc +++ b/tests/fe/interpolate_q_iso_q1.cc @@ -34,7 +34,7 @@ void check(const Function &f, std::vector > values (fe.get_unit_support_points().size(), Vector(1)); f.vector_value_list(fe.get_unit_support_points(), values); - fe.convert_generalized_support_point_values_to_nodal_values(values, dofs); + fe.convert_generalized_support_point_values_to_dof_values(values, dofs); deallog << " vector " << difference(fe,dofs,f) << std::endl; } diff --git a/tests/fe/interpolate_rt.cc b/tests/fe/interpolate_rt.cc index cbc979f0b1..b147f2f957 100644 --- a/tests/fe/interpolate_rt.cc +++ b/tests/fe/interpolate_rt.cc @@ -35,7 +35,7 @@ void check1(const Function &f, std::vector > values (fe.get_generalized_support_points().size(), Vector(dim)); f.vector_value_list(fe.get_generalized_support_points(), values); - fe.convert_generalized_support_point_values_to_nodal_values(values, dofs); + fe.convert_generalized_support_point_values_to_dof_values(values, dofs); deallog << " vector " << vector_difference(fe,dofs,f,0) << std::endl; } diff --git a/tests/fe/interpolate_rtn.cc b/tests/fe/interpolate_rtn.cc index d02eac79de..1f2974b368 100644 --- a/tests/fe/interpolate_rtn.cc +++ b/tests/fe/interpolate_rtn.cc @@ -35,7 +35,7 @@ void check1(const Function &f, std::vector > values (fe.get_generalized_support_points().size(), Vector(dim)); f.vector_value_list(fe.get_generalized_support_points(), values); - fe.convert_generalized_support_point_values_to_nodal_values(values, dofs); + fe.convert_generalized_support_point_values_to_dof_values(values, dofs); deallog << " vector " << vector_difference(fe,dofs,f,0) << std::endl; } diff --git a/tests/fe/interpolate_system.cc b/tests/fe/interpolate_system.cc index f75fa7df2b..57196ea6ea 100644 --- a/tests/fe/interpolate_system.cc +++ b/tests/fe/interpolate_system.cc @@ -37,7 +37,7 @@ void check1(const Function &f, std::vector > values (fe.get_unit_support_points().size(), Vector(comp)); f.vector_value_list(fe.get_unit_support_points(), values); - fe.convert_generalized_support_point_values_to_nodal_values(values, dofs); + fe.convert_generalized_support_point_values_to_dof_values(values, dofs); deallog << " vector " << vector_difference(fe,dofs,f,0) << std::endl; } @@ -59,7 +59,7 @@ void check3(const Function &f, std::vector > values (fe.get_unit_support_points().size(), Vector(f.n_components)); f.vector_value_list(fe.get_unit_support_points(), values); - fe.convert_generalized_support_point_values_to_nodal_values(values, dofs); + fe.convert_generalized_support_point_values_to_dof_values(values, dofs); deallog << " vector " << vector_difference(fe,dofs,f,0) << std::endl; }