Skip to content

Commit

Permalink
Remove FiniteElement::[has|get]_generalized_face_support_points
Browse files Browse the repository at this point in the history
  • Loading branch information
masterleinad committed Apr 13, 2020
1 parent 6a49c44 commit 2cc82f1
Show file tree
Hide file tree
Showing 27 changed files with 37 additions and 1,239 deletions.
5 changes: 5 additions & 0 deletions doc/news/changes/incompatibilities/20200413DanielArndt
@@ -0,0 +1,5 @@
Removed: The deprecated member fucntions
FiniteElement::has_generalized_face_support_points()
and FiniteElement::get_generalized_face_support_points() have been removed.
<br>
(Daniel Arndt, 2020/04/13)
28 changes: 0 additions & 28 deletions include/deal.II/fe/fe.h
Expand Up @@ -2149,34 +2149,6 @@ class FiniteElement : public Subscriptor, public FiniteElementData<dim>
bool
has_generalized_support_points() const;

/**
* Return the equivalent to get_generalized_support_points(), except
* for faces.
*
* @deprecated In general, it is not possible to associate a unique
* subset of generalized support points describing degrees of freedom for
* a given face. Don't use this function
*/
DEAL_II_DEPRECATED
const std::vector<Point<dim - 1>> &
get_generalized_face_support_points() const;

/**
* Return whether a finite element has defined generalized support points on
* faces. If the result is true, then a call to the
* get_generalized_face_support_points() function yields a non-empty array.
*
* For more information, see the documentation for the has_support_points()
* function.
*
* @deprecated In general, it is not possible to associate a unique
* subset of generalized support points describing degrees of freedom for
* a given face. Don't use this function
*/
DEAL_II_DEPRECATED
bool
has_generalized_face_support_points() const;

/**
* For a given degree of freedom, return whether it is logically associated
* with a vertex, line, quad or hex.
Expand Down
24 changes: 0 additions & 24 deletions source/fe/fe.cc
Expand Up @@ -1070,30 +1070,6 @@ FiniteElement<dim, spacedim>::has_face_support_points() const



template <int dim, int spacedim>
const std::vector<Point<dim - 1>> &
FiniteElement<dim, spacedim>::get_generalized_face_support_points() const
{
// a finite element may define
// support points, but only if
// there are as many as there are
// degrees of freedom on a face
return ((generalized_face_support_points.size() == 0) ?
unit_face_support_points :
generalized_face_support_points);
}



template <int dim, int spacedim>
bool
FiniteElement<dim, spacedim>::has_generalized_face_support_points() const
{
return (generalized_face_support_points.size() != 0);
}



template <int dim, int spacedim>
Point<dim - 1>
FiniteElement<dim, spacedim>::unit_face_support_point(
Expand Down
4 changes: 2 additions & 2 deletions source/fe/fe_raviart_thomas_nodal.cc
Expand Up @@ -607,7 +607,7 @@ FE_RaviartThomasNodal<dim>::get_face_interpolation_matrix(
// which returns the support
// points on the face.
Quadrature<dim - 1> quad_face_support(
source_fe.get_generalized_face_support_points());
source_fe.generalized_face_support_points);

// Rule of thumb for FP accuracy,
// that can be expected for a
Expand Down Expand Up @@ -711,7 +711,7 @@ FE_RaviartThomasNodal<dim>::get_subface_interpolation_matrix(
// which returns the support
// points on the face.
Quadrature<dim - 1> quad_face_support(
source_fe.get_generalized_face_support_points());
source_fe.generalized_face_support_points);

// Rule of thumb for FP accuracy,
// that can be expected for a
Expand Down
3 changes: 0 additions & 3 deletions tests/fe/fe_data_test.cc
Expand Up @@ -255,9 +255,6 @@ test_fe_datas()
<< fe_data->get_unit_face_support_points().size() << std::endl;
deallog << "generalized_support_points="
<< fe_data->get_generalized_support_points().size() << std::endl;
deallog << "generalized_face_support_points="
<< fe_data->get_generalized_face_support_points().size()
<< std::endl;

deallog << "face_to_equivalent_cell_index:";
for (unsigned int i = 0; i < fe_data->dofs_per_face; ++i)
Expand Down

0 comments on commit 2cc82f1

Please sign in to comment.