From: Wolfgang Bangerth Date: Thu, 8 Jan 2015 18:46:36 +0000 (-0600) Subject: Remove deprecated functions with names that contain 2nd_derivative. X-Git-Tag: v8.3.0-rc1~559^2~6 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=639db2941d001525438f72fe245c2622ab7d7802;p=dealii.git Remove deprecated functions with names that contain 2nd_derivative. --- diff --git a/include/deal.II/fe/fe_values.h b/include/deal.II/fe/fe_values.h index 02f265a483..ca92f01dd3 100644 --- a/include/deal.II/fe/fe_values.h +++ b/include/deal.II/fe/fe_values.h @@ -1605,14 +1605,6 @@ public: shape_hessian (const unsigned int function_no, const unsigned int point_no) const; - /** - * @deprecated Wrapper for shape_hessian() - */ - const Tensor<2,spacedim> & - shape_2nd_derivative (const unsigned int function_no, - const unsigned int point_no) const DEAL_II_DEPRECATED; - - /** * Return one vector component of the gradient of a shape function at a * quadrature point. If the finite element is scalar, then only component @@ -1634,15 +1626,6 @@ public: const unsigned int point_no, const unsigned int component) const; - /** - * @deprecated Wrapper for shape_hessian_component() - */ - Tensor<2,spacedim> - shape_2nd_derivative_component (const unsigned int function_no, - const unsigned int point_no, - const unsigned int component) const DEAL_II_DEPRECATED; - - //@} /// @name Access to values of global finite element fields //@{ @@ -1994,23 +1977,6 @@ public: VectorSlice > > > hessians, bool quadrature_points_fastest = false) const; - /** - * @deprecated Wrapper for get_function_hessians() - */ - template - void - get_function_2nd_derivatives (const InputVector &, - std::vector > &) const DEAL_II_DEPRECATED; - - /** - * @deprecated Wrapper for get_function_hessians() - */ - template - void - get_function_2nd_derivatives (const InputVector &, - std::vector > > &, - bool = false) const DEAL_II_DEPRECATED; - /** * Compute the (scalar) Laplacian (i.e. the trace of the tensor of second * derivatives) of a finite element at the quadrature points of a cell. This @@ -3941,17 +3907,6 @@ FEValuesBase::shape_hessian (const unsigned int i, -template -inline -const Tensor<2,spacedim> & -FEValuesBase::shape_2nd_derivative (const unsigned int i, - const unsigned int j) const -{ - return shape_hessian(i,j); -} - - - template inline Tensor<2,spacedim> @@ -3982,18 +3937,6 @@ FEValuesBase::shape_hessian_component (const unsigned int i, -template -inline -Tensor<2,spacedim> -FEValuesBase::shape_2nd_derivative_component (const unsigned int i, - const unsigned int j, - const unsigned int component) const -{ - return shape_hessian_component(i,j,component); -} - - - template inline const FiniteElement & @@ -4207,33 +4150,6 @@ FEValuesBase::get_function_grads ( -template -template -inline -void -FEValuesBase:: -get_function_2nd_derivatives (const InputVector &fe_function, - std::vector > &hessians) const -{ - get_function_hessians(fe_function, hessians); -} - - - -template -template -inline -void -FEValuesBase:: -get_function_2nd_derivatives (const InputVector &fe_function, - std::vector > > &hessians, - bool quadrature_points_fastest) const -{ - get_function_hessians(fe_function, hessians, quadrature_points_fastest); -} - - - template inline const Point & diff --git a/tests/bits/step-14.cc b/tests/bits/step-14.cc index 971766a8bc..ca9fb69638 100644 --- a/tests/bits/step-14.cc +++ b/tests/bits/step-14.cc @@ -1814,7 +1814,7 @@ namespace LaplaceSolver cell_data.right_hand_side ->value_list (cell_data.fe_values.get_quadrature_points(), cell_data.rhs_values); - cell_data.fe_values.get_function_2nd_derivatives (primal_solution, + cell_data.fe_values.get_function_hessians (primal_solution, cell_data.cell_grad_grads); cell_data.fe_values.get_function_values (dual_weights, diff --git a/tests/bits/step-15.cc b/tests/bits/step-15.cc index 0d4613af8f..81bb4929b7 100644 --- a/tests/bits/step-15.cc +++ b/tests/bits/step-15.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2005 - 2013 by the deal.II authors +// Copyright (C) 2005 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -414,8 +414,8 @@ void MinimizationProblem<1>::refine_grid () { fe_values.reinit (cell); fe_values.get_function_values (present_solution, local_values); - fe_values.get_function_grads (present_solution, local_gradients); - fe_values.get_function_2nd_derivatives (present_solution, local_2nd_derivs); + fe_values.get_function_gradients (present_solution, local_gradients); + fe_values.get_function_hessians (present_solution, local_2nd_derivs); double cell_residual_norm = 0; for (unsigned int q=0; qvalue_list (cell_data.fe_values.get_present_fe_values().get_quadrature_points(), cell_data.rhs_values); - cell_data.fe_values.get_present_fe_values().get_function_2nd_derivatives (primal_solution, + cell_data.fe_values.get_present_fe_values().get_function_hessians (primal_solution, cell_data.cell_grad_grads); cell_data.fe_values.get_present_fe_values().get_function_values (dual_weights, diff --git a/tests/fail/hp-step-15.cc b/tests/fail/hp-step-15.cc index 00f93dba2f..73cbdda0f7 100644 --- a/tests/fail/hp-step-15.cc +++ b/tests/fail/hp-step-15.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2005 - 2013 by the deal.II authors +// Copyright (C) 2005 - 2013, 2015 by the deal.II authors // // This file is part of the deal.II library. // @@ -416,8 +416,8 @@ void MinimizationProblem<1>::refine_grid () { fe_values.reinit (cell); fe_values.get_present_fe_values().get_function_values (present_solution, local_values); - fe_values.get_present_fe_values().get_function_grads (present_solution, local_gradients); - fe_values.get_present_fe_values().get_function_2nd_derivatives (present_solution, local_2nd_derivs); + fe_values.get_present_fe_values().get_function_gradients (present_solution, local_gradients); + fe_values.get_present_fe_values().get_function_hessians (present_solution, local_2nd_derivs); double cell_residual_norm = 0; for (unsigned int q=0; q