]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Delete unnecessary implementation 2879/head
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Wed, 27 Jul 2016 09:11:39 +0000 (11:11 +0200)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Wed, 27 Jul 2016 21:39:40 +0000 (23:39 +0200)
include/deal.II/fe/fe_tools.h
source/fe/fe_tools.cc
source/fe/fe_tools.inst.in

index c9e108fcd9d224a35bf08e3b4ba208fe880e0fcb..3941a21836c55111914d0ea7313a7429992c48dc 100644 (file)
@@ -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 <int dim, int spacedim>
+  template <int dim, int spacedim
+#ifdef DEAL_II_WITH_CXX11
+            =dim
+#endif
+            >
   FiniteElement<dim, spacedim> *
   get_fe_by_name (const std::string &name);
 
index 7412d6a9f08ab0f9c304bc26fd401aa5791ae606..0d0b73553564f418b7953b8bec6de4db6808beb0 100644 (file)
@@ -2645,18 +2645,8 @@ namespace FETools
 
 
 
-  template <int dim>
-  FiniteElement<dim> *
-  get_fe_by_name (const std::string &parameter_name)
-  {
-    return get_fe_by_name<dim,dim> (parameter_name);
-  }
-
-
-
   template <int dim, int spacedim>
   void
-
   compute_projection_from_quadrature_points_matrix (const FiniteElement<dim,spacedim> &fe,
                                                     const Quadrature<dim>    &lhs_quadrature,
                                                     const Quadrature<dim>    &rhs_quadrature,
index 22ef7b986f85b714a16318c05ec75fd99a5d42c6..b87a95e25fb55a39ee15ac8a1f59369a0e4f6221 100644 (file)
@@ -142,9 +142,6 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
       template FiniteElement<deal_II_dimension> *
       get_fe_from_name<deal_II_dimension> (const std::string &);
 
-      template FiniteElement<deal_II_dimension> *
-      get_fe_by_name<deal_II_dimension> (const std::string &);
-
       template
       void compute_node_matrix(
         FullMatrix<double> &,

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.