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
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
//@{
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
-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>
-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> &
-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> &
// ---------------------------------------------------------------------
//
-// 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.
//
{
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)
// ---------------------------------------------------------------------
//
-// 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.
//
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)
{
// ---------------------------------------------------------------------
//
-// 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.
//
{
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)