]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Replace get_fe_from_name by get_fe_by_name everywhere
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Sun, 10 Jul 2016 21:28:09 +0000 (23:28 +0200)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Wed, 13 Jul 2016 15:04:54 +0000 (17:04 +0200)
28 files changed:
include/deal.II/fe/fe_tools.h
source/fe/fe_abf.cc
source/fe/fe_bdm.cc
source/fe/fe_bernstein.cc
source/fe/fe_dg_vector.cc
source/fe/fe_dgp.cc
source/fe/fe_dgp_monomial.cc
source/fe/fe_dgp_nonparametric.cc
source/fe/fe_dgq.cc
source/fe/fe_face.cc
source/fe/fe_nedelec.cc
source/fe/fe_q.cc
source/fe/fe_q_bubbles.cc
source/fe/fe_q_dg0.cc
source/fe/fe_q_hierarchical.cc
source/fe/fe_q_iso_q1.cc
source/fe/fe_raviart_thomas.cc
source/fe/fe_raviart_thomas_nodal.cc
source/fe/fe_system.cc
source/fe/fe_tools.cc
source/fe/fe_tools.inst.in
source/fe/fe_trace.cc
source/multigrid/mg_transfer_matrix_free.cc
tests/bits/fe_tools_09.cc
tests/bits/fe_tools_10.cc
tests/bits/fe_tools_11.cc
tests/fe/fe_tools_01.cc
tests/lac/constraints_block_01.cc

index 31227841ad25af1ad24ae9efb984d4eb9cd280c9..cbf3c2677e5f480682c43b0d641a80bb3cbc14a9 100644 (file)
@@ -67,7 +67,7 @@ namespace FETools
    * degree. Derived classes are called whenever one wants to have a
    * transparent way to create a finite element object.
    *
-   * This class is used in the FETools::get_fe_from_name() and
+   * This class is used in the FETools::get_fe_by_name() and
    * FETools::add_fe_name() functions.
    *
    * @author Guido Kanschat, 2006
@@ -1150,7 +1150,7 @@ namespace FETools
 
   /**
    * Extend the list of finite elements that can be generated by
-   * get_fe_from_name() by the one given as @p name. If get_fe_from_name() is
+   * get_fe_by_name() by the one given as @p name. If get_fe_by_name() is
    * later called with this name, it will use the object given as second
    * argument to create a finite element object.
    *
@@ -1165,7 +1165,7 @@ namespace FETools
    * used anymore.
    *
    * In most cases, if you want objects of type <code>MyFE</code> be created
-   * whenever the name <code>my_fe</code> is given to get_fe_from_name, you
+   * whenever the name <code>my_fe</code> is given to get_fe_by_name, you
    * will want the second argument to this function be of type
    * FEFactory@<MyFE@>, but you can of course create your custom finite
    * element factory class.
@@ -1175,7 +1175,7 @@ namespace FETools
    * object will be deleted at the end of the program's lifetime.
    *
    * If the name of the element is already in use, an exception is thrown.
-   * Thus, functionality of get_fe_from_name() can only be added, not changed.
+   * Thus, functionality of get_fe_by_name() can only be added, not changed.
    *
    * @note This function manipulates a global table (one table for each space
    * dimension). It is thread safe in the sense that every access to this
@@ -1195,7 +1195,7 @@ namespace FETools
                     const FEFactoryBase<dim,spacedim> *factory);
 
   /**
-   * The string used for get_fe_from_name() cannot be translated to a finite
+   * The string used for get_fe_by_name() cannot be translated to a finite
    * element.
    *
    * Either the string is badly formatted or you are using a custom element
@@ -1209,7 +1209,7 @@ namespace FETools
                   << arg1 << "'.");
 
   /**
-   * The string used for get_fe_from_name() cannot be translated to a finite
+   * The string used for get_fe_by_name() cannot be translated to a finite
    * element.
    *
    * Dimension arguments in finite element names should be avoided. If they
index 32b7046a426ab8a74d3827ca2e734f041788565c..b7ccb126bb386d9cec3c2c5cd72adce2526e12eb 100644 (file)
@@ -110,7 +110,7 @@ std::string
 FE_ABF<dim>::get_name () const
 {
   // note that the
-  // FETools::get_fe_from_name
+  // FETools::get_fe_by_name
   // function depends on the
   // particular format of the string
   // this function returns, so they
index b51b641ce29a29b96daaae938e4ac00d902eb4c5..46cd58045bce28159fc6b3e875a68ca5d067b04e 100644 (file)
@@ -107,7 +107,7 @@ std::string
 FE_BDM<dim>::get_name () const
 {
   // note that the
-  // FETools::get_fe_from_name
+  // FETools::get_fe_by_name
   // function depends on the
   // particular format of the string
   // this function returns, so they
index 6fd68ab662d2d2cf1512b7a8e78b6ad072faa985..5f0197343361929d2ba97be275a2a9510a5a9ebc 100644 (file)
@@ -304,7 +304,7 @@ template <int dim, int spacedim>
 std::string
 FE_Bernstein<dim,spacedim>::get_name () const
 {
-  // note that the FETools::get_fe_from_name function depends on the
+  // note that the FETools::get_fe_by_name function depends on the
   // particular format of the string this function returns, so they have to be
   // kept in synch
 
index e657e5badca5a6fa3a65ca5ca8318cfc7a2337c5..43385f0044af3de3ebf1be7aea30c88d31de19a8 100644 (file)
@@ -32,9 +32,7 @@ template <int dim, int spacedim>
 std::string
 FE_DGNedelec<dim, spacedim>::get_name () const
 {
-  // note that the
-  // FETools::get_fe_from_name
-  // function depends on the
+  // note that the FETools::get_fe_by_nam function depends on the
   // particular format of the string
   // this function returns, so they
   // have to be kept in synch
@@ -59,7 +57,7 @@ std::string
 FE_DGRaviartThomas<dim, spacedim>::get_name () const
 {
   // note that the
-  // FETools::get_fe_from_name
+  // FETools::get_fe_by_name
   // function depends on the
   // particular format of the string
   // this function returns, so they
@@ -85,7 +83,7 @@ std::string
 FE_DGBDM<dim, spacedim>::get_name () const
 {
   // note that the
-  // FETools::get_fe_from_name
+  // FETools::get_fe_by_name
   // function depends on the
   // particular format of the string
   // this function returns, so they
index 62d55adbb7b797a4f67f141d5ab908b0015fc1e4..d9fc284278f713ceeb6ca5b58a6ff60be1e77508 100644 (file)
@@ -48,7 +48,7 @@ template <int dim, int spacedim>
 std::string
 FE_DGP<dim,spacedim>::get_name () const
 {
-  // note that the FETools::get_fe_from_name function depends on the
+  // note that the FETools::get_fe_by_name function depends on the
   // particular format of the string this function returns, so they have to be
   // kept in sync
 
index 9ad2899c1b62a2ca2684f74694b349c0adbbc482..8a0d1e0df204da7a26d8a5c9492f50ed74b06b32 100644 (file)
@@ -141,7 +141,7 @@ std::string
 FE_DGPMonomial<dim>::get_name () const
 {
   // note that the
-  // FETools::get_fe_from_name
+  // FETools::get_fe_by_name
   // function depends on the
   // particular format of the string
   // this function returns, so they
index 584ed1cc33624934d199aa91c5a366ef730fcc2d..70dbf847914f0b38738144b53ba39e46d264df17 100644 (file)
@@ -98,7 +98,7 @@ std::string
 FE_DGPNonparametric<dim,spacedim>::get_name () const
 {
   // note that the
-  // FETools::get_fe_from_name
+  // FETools::get_fe_by_name
   // function depends on the
   // particular format of the string
   // this function returns, so they
index 12c1973c4c5aea7bd49e9071b37edd7ffd5892de..1eb6709a9d2fad0125cc60d1abee35ce375684f7 100644 (file)
@@ -94,7 +94,7 @@ template <int dim, int spacedim>
 std::string
 FE_DGQ<dim, spacedim>::get_name () const
 {
-  // note that the FETools::get_fe_from_name function depends on the
+  // note that the FETools::get_fe_by_name function depends on the
   // particular format of the string this function returns, so they have to be
   // kept in sync
 
@@ -667,7 +667,7 @@ template <int dim, int spacedim>
 std::string
 FE_DGQArbitraryNodes<dim,spacedim>::get_name () const
 {
-  // note that the FETools::get_fe_from_name function does not work for
+  // note that the FETools::get_fe_by_name function does not work for
   // FE_DGQArbitraryNodes since there is no initialization by a degree value.
   std::ostringstream namebuf;
   bool equidistant = true;
index 186dcbe03c1692c283aa34df65e7f2c652ba947d..b0662792ff0f694480bfc319c2a276608ec9711b 100644 (file)
@@ -114,7 +114,7 @@ template <int dim, int spacedim>
 std::string
 FE_FaceQ<dim,spacedim>::get_name () const
 {
-  // note that the FETools::get_fe_from_name function depends on the
+  // note that the FETools::get_fe_by_name function depends on the
   // particular format of the string this function returns, so they have to be
   // kept in synch
   std::ostringstream namebuf;
@@ -341,7 +341,7 @@ template <int spacedim>
 std::string
 FE_FaceQ<1,spacedim>::get_name () const
 {
-  // note that the FETools::get_fe_from_name function depends on the
+  // note that the FETools::get_fe_by_name function depends on the
   // particular format of the string this function returns, so they have to be
   // kept in synch
   std::ostringstream namebuf;
@@ -539,7 +539,7 @@ template <int dim, int spacedim>
 std::string
 FE_FaceP<dim,spacedim>::get_name () const
 {
-  // note that the FETools::get_fe_from_name function depends on the
+  // note that the FETools::get_fe_by_name function depends on the
   // particular format of the string this function returns, so they have to be
   // kept in synch
   std::ostringstream namebuf;
@@ -763,7 +763,7 @@ template <int spacedim>
 std::string
 FE_FaceP<1,spacedim>::get_name () const
 {
-  // note that the FETools::get_fe_from_name function depends on the
+  // note that the FETools::get_fe_by_name function depends on the
   // particular format of the string this function returns, so they have to be
   // kept in synch
   std::ostringstream namebuf;
index 2954d25e5d3b6745a83f0bda31fba0406ff6d2d7..1ef22756d36641d6490cb747095602c49900a2a8 100644 (file)
@@ -192,7 +192,7 @@ std::string
 FE_Nedelec<dim>::get_name () const
 {
   // note that the
-  // FETools::get_fe_from_name
+  // FETools::get_fe_by_name
   // function depends on the
   // particular format of the string
   // this function returns, so they
index 2147adffba7280a4f07c9d0352efe399b64a561e..b4bb63eed56ab85a6be6f67c1bc3fb6efd0605de 100644 (file)
@@ -75,7 +75,7 @@ template <int dim, int spacedim>
 std::string
 FE_Q<dim,spacedim>::get_name () const
 {
-  // note that the FETools::get_fe_from_name function depends on the
+  // note that the FETools::get_fe_by_name function depends on the
   // particular format of the string this function returns, so they have to be
   // kept in synch
 
index 9868ae39abb8526e0f9829e52909810b6dc33555..a7a7e6b86cc544642fae2818ecdbf8f2f40f4aa0 100644 (file)
@@ -247,7 +247,7 @@ template <int dim, int spacedim>
 std::string
 FE_Q_Bubbles<dim,spacedim>::get_name () const
 {
-  // note that the FETools::get_fe_from_name function depends on the
+  // note that the FETools::get_fe_by_name function depends on the
   // particular format of the string this function returns, so they have to be
   // kept in synch
 
index d2218eadc9bf38b4e284bee6a21ad0ce277e38ca..4e0fe23ab31d456df7898eb60cbec5d4a23cb524 100644 (file)
@@ -88,7 +88,7 @@ template <int dim, int spacedim>
 std::string
 FE_Q_DG0<dim,spacedim>::get_name () const
 {
-  // note that the FETools::get_fe_from_name function depends on the
+  // note that the FETools::get_fe_by_name function depends on the
   // particular format of the string this function returns, so they have to be
   // kept in synch
 
index a3a7641eaa16e2fb4b207758fc17a56f7852424b..f146a71825989b9096086ae27d9868a47933355d 100644 (file)
@@ -110,7 +110,7 @@ std::string
 FE_Q_Hierarchical<dim>::get_name () const
 {
   // note that the
-  // FETools::get_fe_from_name
+  // FETools::get_fe_by_name
   // function depends on the
   // particular format of the string
   // this function returns, so they
index 35747b15e6cc12b509e94ea04c6097ca48075737..4b2bb7f1241a9c60d4d28e0b3974224123bec893 100644 (file)
@@ -54,7 +54,7 @@ template <int dim, int spacedim>
 std::string
 FE_Q_iso_Q1<dim,spacedim>::get_name () const
 {
-  // note that the FETools::get_fe_from_name function depends on the
+  // note that the FETools::get_fe_by_name function depends on the
   // particular format of the string this function returns, so they have to be
   // kept in sync
 
index 39b7b1e822a619531605c07d0ae6d8c3b9326f4b..7503a5736f100eb0604a138bc2252c414dbc609d 100644 (file)
@@ -111,7 +111,7 @@ std::string
 FE_RaviartThomas<dim>::get_name () const
 {
   // note that the
-  // FETools::get_fe_from_name
+  // FETools::get_fe_by_name
   // function depends on the
   // particular format of the string
   // this function returns, so they
index 7a103be2a6151158574a96a64150486c6c4e87d6..3556c6851ab00d97b457f4b76045e2ed2736ee20 100644 (file)
@@ -108,7 +108,7 @@ std::string
 FE_RaviartThomasNodal<dim>::get_name () const
 {
   // note that the
-  // FETools::get_fe_from_name
+  // FETools::get_fe_by_name
   // function depends on the
   // particular format of the string
   // this function returns, so they
index f51088b4cf00a5fa6d218057b324cc862dc49321..862dc641b19bc3f142ff33382ddb2902dcebe3a4 100644 (file)
@@ -292,7 +292,7 @@ std::string
 FESystem<dim,spacedim>::get_name () const
 {
   // note that the
-  // FETools::get_fe_from_name
+  // FETools::get_fe_by_name
   // function depends on the
   // particular format of the string
   // this function returns, so they
index 58e0bbc736d5e38d1055b057ad15433345f81d05..b297ab6ce223653116fae1e4bfae1bde90f3d223 100644 (file)
@@ -1165,7 +1165,7 @@ namespace
   static
   Threads::Mutex fe_name_map_lock;
 
-  // This is the map used by FETools::get_fe_from_name and
+  // This is the map used by FETools::get_fe_by_name and
   // FETools::add_fe_name. It is only accessed by functions in this
   // file, so it is safe to make it a static variable here. It must be
   // static so that we can link several dimensions together.
@@ -2262,10 +2262,10 @@ namespace FETools
       // smarter?
       template <int dim, int spacedim>
       FiniteElement<dim,spacedim> *
-      get_fe_from_name_ext (std::string &name,
-                            const std::map<std::string,
-                            std_cxx11::shared_ptr<const Subscriptor> >
-                            &fe_name_map)
+      get_fe_by_name_ext (std::string &name,
+                          const std::map<std::string,
+                          std_cxx11::shared_ptr<const Subscriptor> >
+                          &fe_name_map)
       {
         // Extract the name of the
         // finite element class, which only
@@ -2309,8 +2309,8 @@ namespace FETools
                     // Now, the name of the
                     // first base element is
                     // first... Let's get it
-                    base_fes.push_back (get_fe_from_name_ext<dim,spacedim> (name,
-                                                                            fe_name_map));
+                    base_fes.push_back (get_fe_by_name_ext<dim,spacedim> (name,
+                                                                          fe_name_map));
                     // next check whether
                     // FESystem placed a
                     // multiplicity after
@@ -2511,9 +2511,9 @@ namespace FETools
 
 
       template <int dim,int spacedim>
-      FiniteElement<dim,spacedim> *get_fe_from_name (std::string &name)
+      FiniteElement<dim,spacedim> *get_fe_by_name (std::string &name)
       {
-        return get_fe_from_name_ext<dim,spacedim> (name, fe_name_map[dim][spacedim]);
+        return get_fe_by_name_ext<dim,spacedim> (name, fe_name_map[dim][spacedim]);
       }
     }
   }
@@ -2591,7 +2591,7 @@ namespace FETools
 
     try
       {
-        FiniteElement<dim,spacedim> *fe = internal::get_fe_from_name<dim,spacedim> (name);
+        FiniteElement<dim,spacedim> *fe = internal::get_fe_by_name<dim,spacedim> (name);
 
         // Make sure the auxiliary function
         // ate up all characters of the name.
@@ -2613,7 +2613,7 @@ namespace FETools
 
   template <int dim>
   FiniteElement<dim> *
-  get_fe_from_name (const std::string &parameter_name)
+  get_fe_by_name (const std::string &parameter_name)
   {
     return get_fe_by_name<dim,dim> (parameter_name);
   }
index b87a95e25fb55a39ee15ac8a1f59369a0e4f6221..cab12e7e593218ef649d9c7da1ea3b5c6fa7ac1e 100644 (file)
@@ -140,7 +140,7 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
       template class FEFactoryBase<deal_II_dimension>;
 
       template FiniteElement<deal_II_dimension> *
-      get_fe_from_name<deal_II_dimension> (const std::string &);
+      get_fe_by_name<deal_II_dimension> (const std::string &);
 
       template
       void compute_node_matrix(
index 1e0509ee291db0ee38f5f74f3539cd8d04ec5a30..78992e00edfc0314fef146dda689311ae09bcdf9 100644 (file)
@@ -68,7 +68,7 @@ template <int dim, int spacedim>
 std::string
 FE_TraceQ<dim,spacedim>::get_name () const
 {
-  // note that the FETools::get_fe_from_name function depends on the
+  // note that the FETools::get_fe_by_name function depends on the
   // particular format of the string this function returns, so they have to be
   // kept in synch
 
@@ -232,7 +232,7 @@ template <int spacedim>
 std::string
 FE_TraceQ<1,spacedim>::get_name () const
 {
-  // note that the FETools::get_fe_from_name function depends on the
+  // note that the FETools::get_fe_by_name function depends on the
   // particular format of the string this function returns, so they have to be
   // kept in synch
   std::ostringstream namebuf;
index 3c727441cc80f4e7964069c78cf08e519918ca6b..b6857eb90e2249cce6c3aec4b5564cfa966a5bc1 100644 (file)
@@ -235,7 +235,7 @@ void MGTransferMatrixFree<dim,Number>::build
     fe_name[template_starts+1] = '1';
   }
   std_cxx11::shared_ptr<FiniteElement<1> > fe_1d
-  (FETools::get_fe_from_name<1>(fe_name));
+  (FETools::get_fe_by_name<1,1>(fe_name));
   const FiniteElement<1> &fe = *fe_1d;
   unsigned int n_child_dofs_1d = numbers::invalid_unsigned_int;
 
index 6a86c9e6b1eea2daa098f2cfe21ad3cd1399d5ef..d058e3d72f19499cb318217185220bd7d3bad8cd 100644 (file)
@@ -19,7 +19,7 @@
 #include <deal.II/lac/sparsity_pattern.h>
 
 // check
-//   FETools::get_fe_from_name
+//   FETools::get_fe_by_name
 
 
 std::string output_file_name = "output";
@@ -39,7 +39,7 @@ check_this (const FiniteElement<dim> &fe1,
   // pretty good indication that the
   // two FEs are actually the same
   deallog << fe1.get_name();
-  p1 = FETools::get_fe_from_name<dim> (fe1.get_name());
+  p1 = FETools::get_fe_by_name<dim, dim> (fe1.get_name());
   AssertThrow (fe1.get_name() == p1->get_name(),
                ExcInternalError());
   deallog << " ok" << std::endl;
@@ -47,7 +47,7 @@ check_this (const FiniteElement<dim> &fe1,
 
   // same for fe2
   deallog << fe2.get_name();
-  p2 = FETools::get_fe_from_name<dim> (fe2.get_name());
+  p2 = FETools::get_fe_by_name<dim, dim> (fe2.get_name());
   AssertThrow (fe2.get_name() == p2->get_name(),
                ExcInternalError());
   deallog << " ok" << std::endl;
index deeb254a2806cdc281014465efae7ea4fa783aaa..915f4dbbbfef7ca22d62e905e0c266bcb17b97cd 100644 (file)
@@ -19,7 +19,7 @@
 #include <deal.II/lac/sparsity_pattern.h>
 
 // check
-//   FETools::get_fe_from_name
+//   FETools::get_fe_by_name
 // like fe_tools_09, but with the difference that we use the generic
 // "<dim>" marker in the finite element name, instead of the one with
 // the concrete dimension (see the documentation)
@@ -59,7 +59,7 @@ check_this (const FiniteElement<dim> &fe1,
   // pretty good indication that the
   // two FEs are actually the same
   deallog << modify_name<dim> (fe1.get_name());
-  p1 = FETools::get_fe_from_name<dim> (modify_name<dim> (fe1.get_name()));
+  p1 = FETools::get_fe_by_name<dim, dim> (modify_name<dim> (fe1.get_name()));
   AssertThrow (fe1.get_name() == p1->get_name(),
                ExcInternalError());
   deallog << " ok" << std::endl;
@@ -67,7 +67,7 @@ check_this (const FiniteElement<dim> &fe1,
 
   // same for fe2
   deallog << modify_name<dim> (fe2.get_name());
-  p2 = FETools::get_fe_from_name<dim> (modify_name<dim> (fe2.get_name()));
+  p2 = FETools::get_fe_by_name<dim, dim> (modify_name<dim> (fe2.get_name()));
   AssertThrow (fe2.get_name() == p2->get_name(),
                ExcInternalError());
   deallog << " ok" << std::endl;
index 731d767ff14f0815408f10e046fb6c6c27f822cc..dcd2918647b1e4e9df0d426145f8ec85596e287c 100644 (file)
@@ -19,7 +19,7 @@
 #include <deal.II/lac/sparsity_pattern.h>
 
 // check
-//   FETools::get_fe_from_name
+//   FETools::get_fe_by_name
 // like fe_tools_09 and fe_tools_10, but this time with no dimension
 // marker at all (see the documentation)
 
@@ -58,7 +58,7 @@ check_this (const FiniteElement<dim> &fe1,
   // pretty good indication that the
   // two FEs are actually the same
   deallog << modify_name<dim> (fe1.get_name());
-  p1 = FETools::get_fe_from_name<dim> (modify_name<dim> (fe1.get_name()));
+  p1 = FETools::get_fe_by_name<dim, dim> (modify_name<dim> (fe1.get_name()));
   AssertThrow (fe1.get_name() == p1->get_name(),
                ExcInternalError());
   deallog << " ok" << std::endl;
@@ -66,7 +66,7 @@ check_this (const FiniteElement<dim> &fe1,
 
   // same for fe2
   deallog << modify_name<dim> (fe2.get_name());
-  p2 = FETools::get_fe_from_name<dim> (modify_name<dim> (fe2.get_name()));
+  p2 = FETools::get_fe_by_name<dim, dim> (modify_name<dim> (fe2.get_name()));
   AssertThrow (fe2.get_name() == p2->get_name(),
                ExcInternalError());
   deallog << " ok" << std::endl;
index d9f5d9082856cc64bfdc25d26746b2a0d2e0db6e..b5f9cd47bb8c0d8f6e1d1f3dd58fe2a1379c959c 100644 (file)
@@ -30,7 +30,7 @@
 template <int dim>
 void test_fe(const char *name)
 {
-  FiniteElement<dim> *fe = FETools::get_fe_from_name<dim>(std::string(name));
+  FiniteElement<dim> *fe = FETools::get_fe_by_name<dim, dim>(std::string(name));
 
   deallog << fe->get_name() << std::endl
           << '\t' << fe->dofs_per_cell
index fff3f93253e27b21cddf2bbcf5c0f20894799944..2c36c0bc3d4cec15985b8fe6b6f72218039895ca 100644 (file)
@@ -114,8 +114,8 @@ int main ()
   std::string fluid_fe_name = "FESystem[FE_Nothing()^2-FE_Nothing()^2-FE_Q(2)^2-FE_Q(1)-FE_Q(2)^2]";
 
   hp::FECollection<dim> fe_collection;
-  FiniteElement<dim> *solid_fe = FETools::get_fe_from_name<dim>(solid_fe_name);
-  FiniteElement<dim> *fluid_fe = FETools::get_fe_from_name<dim>(fluid_fe_name);
+  FiniteElement<dim> *solid_fe = FETools::get_fe_by_name<dim, dim>(solid_fe_name);
+  FiniteElement<dim> *fluid_fe = FETools::get_fe_by_name<dim, dim>(fluid_fe_name);
 
   deallog << "Solid FE Space: " << solid_fe->get_name() << std::endl;
   deallog << "Fluid/Mesh FE Space: " << fluid_fe->get_name() << std::endl;

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.