From f5fcbd8e6114ca5b17a9487d85a06ac01c86ea3c Mon Sep 17 00:00:00 2001 From: Daniel Arndt Date: Wed, 27 Jul 2016 11:11:39 +0200 Subject: [PATCH] Delete unnecessary implementation --- include/deal.II/fe/fe_tools.h | 6 +++++- source/fe/fe_tools.cc | 10 ---------- source/fe/fe_tools.inst.in | 3 --- 3 files changed, 5 insertions(+), 14 deletions(-) diff --git a/include/deal.II/fe/fe_tools.h b/include/deal.II/fe/fe_tools.h index c9e108fcd9..3941a21836 100644 --- a/include/deal.II/fe/fe_tools.h +++ b/include/deal.II/fe/fe_tools.h @@ -1135,7 +1135,11 @@ namespace FETools * function, use the add_fe_name() function. This function does not work if * one wants to get a codimension 1 finite element. */ - template + template FiniteElement * get_fe_by_name (const std::string &name); diff --git a/source/fe/fe_tools.cc b/source/fe/fe_tools.cc index 7412d6a9f0..0d0b735535 100644 --- a/source/fe/fe_tools.cc +++ b/source/fe/fe_tools.cc @@ -2645,18 +2645,8 @@ namespace FETools - template - FiniteElement * - get_fe_by_name (const std::string ¶meter_name) - { - return get_fe_by_name (parameter_name); - } - - - template void - compute_projection_from_quadrature_points_matrix (const FiniteElement &fe, const Quadrature &lhs_quadrature, const Quadrature &rhs_quadrature, diff --git a/source/fe/fe_tools.inst.in b/source/fe/fe_tools.inst.in index 22ef7b986f..b87a95e25f 100644 --- a/source/fe/fe_tools.inst.in +++ b/source/fe/fe_tools.inst.in @@ -142,9 +142,6 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS template FiniteElement * get_fe_from_name (const std::string &); - template FiniteElement * - get_fe_by_name (const std::string &); - template void compute_node_matrix( FullMatrix &, -- 2.39.5