From: Wolfgang Bangerth Date: Wed, 21 Aug 2019 19:54:59 +0000 (-0600) Subject: Rename TensorPolynomials::compute() to ::evaluate(). X-Git-Tag: v9.2.0-rc1~1194^2~2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=2980deedaf6957559a8abba82b86b08bd6139bd9;p=dealii.git Rename TensorPolynomials::compute() to ::evaluate(). We've used this kind of terminology in a number of other places. The point is that we don't 'compute' the polynomial at that point; its form is fixed. Rather, we 'evaluate' the polynomial for a particular value of its argument. --- diff --git a/include/deal.II/base/polynomials_abf.h b/include/deal.II/base/polynomials_abf.h index 44ef70688b..74f37dc403 100644 --- a/include/deal.II/base/polynomials_abf.h +++ b/include/deal.II/base/polynomials_abf.h @@ -78,12 +78,12 @@ public: * in a loop over all tensor product polynomials. */ void - compute(const Point & unit_point, - std::vector> &values, - std::vector> &grads, - std::vector> &grad_grads, - std::vector> &third_derivatives, - std::vector> &fourth_derivatives) const override; + evaluate(const Point & unit_point, + std::vector> &values, + std::vector> &grads, + std::vector> &grad_grads, + std::vector> &third_derivatives, + std::vector> &fourth_derivatives) const override; /** * Return the name of the space, which is ABF. diff --git a/include/deal.II/base/polynomials_bdm.h b/include/deal.II/base/polynomials_bdm.h index be37ecc584..75a4bde8fb 100644 --- a/include/deal.II/base/polynomials_bdm.h +++ b/include/deal.II/base/polynomials_bdm.h @@ -124,12 +124,12 @@ public: * in a loop over all tensor product polynomials. */ void - compute(const Point & unit_point, - std::vector> &values, - std::vector> &grads, - std::vector> &grad_grads, - std::vector> &third_derivatives, - std::vector> &fourth_derivatives) const override; + evaluate(const Point & unit_point, + std::vector> &values, + std::vector> &grads, + std::vector> &grad_grads, + std::vector> &third_derivatives, + std::vector> &fourth_derivatives) const override; /** * Return the degree of the BDM space, which is one less than the highest diff --git a/include/deal.II/base/polynomials_bernardi_raugel.h b/include/deal.II/base/polynomials_bernardi_raugel.h index 3c4c605256..d83a2e4d1c 100644 --- a/include/deal.II/base/polynomials_bernardi_raugel.h +++ b/include/deal.II/base/polynomials_bernardi_raugel.h @@ -113,12 +113,12 @@ public: * in a loop over all tensor product polynomials. */ void - compute(const Point & unit_point, - std::vector> &values, - std::vector> &grads, - std::vector> &grad_grads, - std::vector> &third_derivatives, - std::vector> &fourth_derivatives) const override; + evaluate(const Point & unit_point, + std::vector> &values, + std::vector> &grads, + std::vector> &grad_grads, + std::vector> &third_derivatives, + std::vector> &fourth_derivatives) const override; /** * Return the number of polynomials in the space BR(degree) without diff --git a/include/deal.II/base/polynomials_nedelec.h b/include/deal.II/base/polynomials_nedelec.h index ef1e061a26..2907344879 100644 --- a/include/deal.II/base/polynomials_nedelec.h +++ b/include/deal.II/base/polynomials_nedelec.h @@ -75,12 +75,12 @@ public: * in a loop over all tensor product polynomials. */ void - compute(const Point & unit_point, - std::vector> &values, - std::vector> &grads, - std::vector> &grad_grads, - std::vector> &third_derivatives, - std::vector> &fourth_derivatives) const override; + evaluate(const Point & unit_point, + std::vector> &values, + std::vector> &grads, + std::vector> &grad_grads, + std::vector> &third_derivatives, + std::vector> &fourth_derivatives) const override; /** * Return the name of the space, which is Nedelec. diff --git a/include/deal.II/base/polynomials_raviart_thomas.h b/include/deal.II/base/polynomials_raviart_thomas.h index c0cd7c7bc4..0176e3714f 100644 --- a/include/deal.II/base/polynomials_raviart_thomas.h +++ b/include/deal.II/base/polynomials_raviart_thomas.h @@ -73,12 +73,12 @@ public: * in a loop over all tensor product polynomials. */ void - compute(const Point & unit_point, - std::vector> &values, - std::vector> &grads, - std::vector> &grad_grads, - std::vector> &third_derivatives, - std::vector> &fourth_derivatives) const override; + evaluate(const Point & unit_point, + std::vector> &values, + std::vector> &grads, + std::vector> &grad_grads, + std::vector> &third_derivatives, + std::vector> &fourth_derivatives) const override; /** * Return the name of the space, which is RaviartThomas. diff --git a/include/deal.II/base/polynomials_rt_bubbles.h b/include/deal.II/base/polynomials_rt_bubbles.h index a77f1af360..04fe4da5b4 100644 --- a/include/deal.II/base/polynomials_rt_bubbles.h +++ b/include/deal.II/base/polynomials_rt_bubbles.h @@ -107,12 +107,12 @@ public: * in a loop over all tensor product polynomials. */ void - compute(const Point & unit_point, - std::vector> &values, - std::vector> &grads, - std::vector> &grad_grads, - std::vector> &third_derivatives, - std::vector> &fourth_derivatives) const override; + evaluate(const Point & unit_point, + std::vector> &values, + std::vector> &grads, + std::vector> &grad_grads, + std::vector> &third_derivatives, + std::vector> &fourth_derivatives) const override; /** * Return the name of the space, which is RT_Bubbles. diff --git a/include/deal.II/base/tensor_polynomials_base.h b/include/deal.II/base/tensor_polynomials_base.h index cbd82f3767..c8c1e286db 100644 --- a/include/deal.II/base/tensor_polynomials_base.h +++ b/include/deal.II/base/tensor_polynomials_base.h @@ -37,8 +37,8 @@ DEAL_II_NAMESPACE_OPEN * * Any derived class must provide the most basic properties for shape * functions evaluated on the reference cell. This includes, but is not - * limited to, implementing the compute, name, and - * clone member functions. These functions are necessary to store the + * limited to, implementing the evaluate(), name(), and + * clone() member functions. These functions are necessary to store the * most basic information of how the polynomials in the derived class evaluate * at a given point on the reference cell. More information on each function can * be found in the corresponding function's documentation. @@ -97,12 +97,12 @@ public: * in a loop over all tensor product polynomials. */ virtual void - compute(const Point & unit_point, - std::vector> &values, - std::vector> &grads, - std::vector> &grad_grads, - std::vector> &third_derivatives, - std::vector> &fourth_derivatives) const = 0; + evaluate(const Point & unit_point, + std::vector> &values, + std::vector> &grads, + std::vector> &grad_grads, + std::vector> &third_derivatives, + std::vector> &fourth_derivatives) const = 0; /** * Return the number of polynomials. diff --git a/include/deal.II/fe/fe_poly_tensor.h b/include/deal.II/fe/fe_poly_tensor.h index 1fa69c4156..82aadeb6e2 100644 --- a/include/deal.II/fe/fe_poly_tensor.h +++ b/include/deal.II/fe/fe_poly_tensor.h @@ -322,12 +322,12 @@ protected: if (update_flags & (update_values | update_gradients)) for (unsigned int k = 0; k < n_q_points; ++k) { - poly_space->compute(quadrature.point(k), - values, - grads, - grad_grads, - third_derivatives, - fourth_derivatives); + poly_space->evaluate(quadrature.point(k), + values, + grads, + grad_grads, + third_derivatives, + fourth_derivatives); if (update_flags & update_values) { diff --git a/source/base/polynomials_abf.cc b/source/base/polynomials_abf.cc index 6bd98f5747..5d825474e0 100644 --- a/source/base/polynomials_abf.cc +++ b/source/base/polynomials_abf.cc @@ -61,7 +61,7 @@ PolynomialsABF::PolynomialsABF(const unsigned int k) template void -PolynomialsABF::compute( +PolynomialsABF::evaluate( const Point & unit_point, std::vector> &values, std::vector> &grads, diff --git a/source/base/polynomials_bdm.cc b/source/base/polynomials_bdm.cc index 4669b0ddbb..5c0d8d811a 100644 --- a/source/base/polynomials_bdm.cc +++ b/source/base/polynomials_bdm.cc @@ -53,7 +53,7 @@ PolynomialsBDM::PolynomialsBDM(const unsigned int k) template void -PolynomialsBDM::compute( +PolynomialsBDM::evaluate( const Point & unit_point, std::vector> &values, std::vector> &grads, diff --git a/source/base/polynomials_bernardi_raugel.cc b/source/base/polynomials_bernardi_raugel.cc index 62e643274e..43d9fd22c5 100644 --- a/source/base/polynomials_bernardi_raugel.cc +++ b/source/base/polynomials_bernardi_raugel.cc @@ -67,7 +67,7 @@ PolynomialsBernardiRaugel::create_polynomials_Q() template void -PolynomialsBernardiRaugel::compute( +PolynomialsBernardiRaugel::evaluate( const Point & unit_point, std::vector> &values, std::vector> &grads, diff --git a/source/base/polynomials_nedelec.cc b/source/base/polynomials_nedelec.cc index de531fada5..f72966a4b4 100644 --- a/source/base/polynomials_nedelec.cc +++ b/source/base/polynomials_nedelec.cc @@ -51,7 +51,7 @@ PolynomialsNedelec::create_polynomials(const unsigned int k) // polynomial at the given point. template void -PolynomialsNedelec::compute( +PolynomialsNedelec::evaluate( const Point & unit_point, std::vector> &values, std::vector> &grads, diff --git a/source/base/polynomials_raviart_thomas.cc b/source/base/polynomials_raviart_thomas.cc index d15e210ca8..1ea3176bc6 100644 --- a/source/base/polynomials_raviart_thomas.cc +++ b/source/base/polynomials_raviart_thomas.cc @@ -61,7 +61,7 @@ PolynomialsRaviartThomas::create_polynomials(const unsigned int k) template void -PolynomialsRaviartThomas::compute( +PolynomialsRaviartThomas::evaluate( const Point & unit_point, std::vector> &values, std::vector> &grads, diff --git a/source/base/polynomials_rt_bubbles.cc b/source/base/polynomials_rt_bubbles.cc index c4412c930c..e85d165c22 100644 --- a/source/base/polynomials_rt_bubbles.cc +++ b/source/base/polynomials_rt_bubbles.cc @@ -42,7 +42,7 @@ PolynomialsRT_Bubbles::PolynomialsRT_Bubbles(const unsigned int k) template void -PolynomialsRT_Bubbles::compute( +PolynomialsRT_Bubbles::evaluate( const Point & unit_point, std::vector> &values, std::vector> &grads, @@ -89,12 +89,12 @@ PolynomialsRT_Bubbles::compute( p_grad_grads.resize((grad_grads.size() == 0) ? 0 : n_sub); // This is the Raviart-Thomas part of the space - raviart_thomas_space.compute(unit_point, - p_values, - p_grads, - p_grad_grads, - p_third_derivatives, - p_fourth_derivatives); + raviart_thomas_space.evaluate(unit_point, + p_values, + p_grads, + p_grad_grads, + p_third_derivatives, + p_fourth_derivatives); for (unsigned int i = 0; i < p_values.size(); ++i) values[i] = p_values[i]; for (unsigned int i = 0; i < p_grads.size(); ++i) diff --git a/source/fe/fe_poly_tensor.cc b/source/fe/fe_poly_tensor.cc index c7222ae526..a54c39a9f0 100644 --- a/source/fe/fe_poly_tensor.cc +++ b/source/fe/fe_poly_tensor.cc @@ -255,7 +255,7 @@ FE_PolyTensor::shape_value_component( std::vector> dummy1; std::vector> dummy2; - poly_space->compute( + poly_space->evaluate( p, cached_values, cached_grads, cached_grad_grads, dummy1, dummy2); } @@ -300,7 +300,7 @@ FE_PolyTensor::shape_grad_component( std::vector> dummy1; std::vector> dummy2; - poly_space->compute( + poly_space->evaluate( p, cached_values, cached_grads, cached_grad_grads, dummy1, dummy2); } @@ -346,7 +346,7 @@ FE_PolyTensor::shape_grad_grad_component( std::vector> dummy1; std::vector> dummy2; - poly_space->compute( + poly_space->evaluate( p, cached_values, cached_grads, cached_grad_grads, dummy1, dummy2); }