]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove deprecated functions with names that contain 2nd_derivative.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Thu, 8 Jan 2015 18:46:36 +0000 (12:46 -0600)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Fri, 9 Jan 2015 18:04:27 +0000 (12:04 -0600)
include/deal.II/fe/fe_values.h
tests/bits/step-14.cc
tests/bits/step-15.cc
tests/deal.II/derivatives.cc
tests/fail/hp-step-14.cc
tests/fail/hp-step-15.cc

index 02f265a483492b0b9d75c2561d28cb6c301ba139..ca92f01dd3f87471a81965391ea94f0f3dfc5310 100644 (file)
@@ -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<std::vector<std::vector<Tensor<2,spacedim> > > > hessians,
     bool quadrature_points_fastest = false) const;
 
-  /**
-   * @deprecated Wrapper for get_function_hessians()
-   */
-  template <class InputVector>
-  void
-  get_function_2nd_derivatives (const InputVector &,
-                                std::vector<Tensor<2,spacedim> > &) const DEAL_II_DEPRECATED;
-
-  /**
-   * @deprecated Wrapper for get_function_hessians()
-   */
-  template <class InputVector>
-  void
-  get_function_2nd_derivatives (const InputVector &,
-                                std::vector<std::vector<Tensor<2,spacedim> > > &,
-                                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<dim,spacedim>::shape_hessian (const unsigned int i,
 
 
 
-template <int dim, int spacedim>
-inline
-const Tensor<2,spacedim> &
-FEValuesBase<dim,spacedim>::shape_2nd_derivative (const unsigned int i,
-                                                  const unsigned int j) const
-{
-  return shape_hessian(i,j);
-}
-
-
-
 template <int dim, int spacedim>
 inline
 Tensor<2,spacedim>
@@ -3982,18 +3937,6 @@ FEValuesBase<dim,spacedim>::shape_hessian_component (const unsigned int i,
 
 
 
-template <int dim, int spacedim>
-inline
-Tensor<2,spacedim>
-FEValuesBase<dim,spacedim>::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 <int dim, int spacedim>
 inline
 const FiniteElement<dim,spacedim> &
@@ -4207,33 +4150,6 @@ FEValuesBase<dim,spacedim>::get_function_grads (
 
 
 
-template <int dim, int spacedim>
-template <class InputVector>
-inline
-void
-FEValuesBase<dim,spacedim>::
-get_function_2nd_derivatives (const InputVector           &fe_function,
-                              std::vector<Tensor<2,spacedim> > &hessians) const
-{
-  get_function_hessians(fe_function, hessians);
-}
-
-
-
-template <int dim, int spacedim>
-template <class InputVector>
-inline
-void
-FEValuesBase<dim,spacedim>::
-get_function_2nd_derivatives (const InputVector                         &fe_function,
-                              std::vector<std::vector<Tensor<2,spacedim> > > &hessians,
-                              bool quadrature_points_fastest) const
-{
-  get_function_hessians(fe_function, hessians, quadrature_points_fastest);
-}
-
-
-
 template <int dim, int spacedim>
 inline
 const Point<spacedim> &
index 971766a8bc88618a2f6694d32de7c7b6c87aceb4..ca9fb69638c5d7de82477c4f25a2d2c155e1a0bf 100644 (file)
@@ -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,
index 0d4613af8fdfdcd25baf05dbb0b8391ee4ebfad8..81bb4929b710b2e9250dd80198a480bf9d09bf1c 100644 (file)
@@ -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; q<quadrature.size(); ++q)
index 9b3876907a1046f24c47496ccadd60ab5d9f150d..0921f8dc2569370a82be684fb5defa974f7910f8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 by the deal.II authors
+// Copyright (C) 2013, 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -139,8 +139,8 @@ check (const unsigned int level,
       cosine.gradient_list (fe2.get_quadrature_points(), Df);
       cosine.hessian_list (fe2.get_quadrature_points(), DDf);
       fe2.get_function_values (u, u_local);
-      fe2.get_function_grads (u, Du);
-      fe2.get_function_2nd_derivatives (u,DDu);
+      fe2.get_function_gradients (u, Du);
+      fe2.get_function_hessians (u,DDu);
 
       for (unsigned int k=0; k<quadrature.size(); ++k)
         {
index bf1eafc8f847378d5404199b9cd4bbaf09049117..22d842a78a32f3c252b589177f4f6abbeeffcfc4 100644 (file)
@@ -1808,7 +1808,7 @@ namespace LaplaceSolver
     cell_data.right_hand_side
     ->value_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,
index 00f93dba2f16c4c7fb01ad2d1399dd3ad2b9c2bc..73cbdda0f7712f69b2d63e7f7cea4fbdf512e5ca 100644 (file)
@@ -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<quadrature[0].size(); ++q)

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.