]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Adjust empty lines between functions in fe_tools.cc 2856/head
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Sun, 24 Jul 2016 13:10:54 +0000 (15:10 +0200)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Sun, 24 Jul 2016 13:10:54 +0000 (15:10 +0200)
source/fe/fe_tools.cc

index 3a78c29aec9887bf8fffddaeb54c1431725c8b34..7412d6a9f08ab0f9c304bc26fd401aa5791ae606 100644 (file)
@@ -151,6 +151,8 @@ namespace FETools
                                      block_indices);
     }
 
+
+
     template <int dim, int spacedim>
     FiniteElementData<dim>
     multiply_dof_numbers (const FiniteElement<dim,spacedim> *fe1,
@@ -180,6 +182,8 @@ namespace FETools
       return multiply_dof_numbers(fes, mult);
     }
 
+
+
     template <int dim, int spacedim>
     std::vector<bool>
     compute_restriction_is_additive_flags (const std::vector<const FiniteElement<dim,spacedim>*> &fes,
@@ -530,6 +534,7 @@ namespace FETools
     }
 
 
+
     /**
      * Compute the non-zero vector components of a composed finite element.
      */
@@ -569,6 +574,8 @@ namespace FETools
                                          do_tensor_product);
     }
 
+
+
     template <int dim, int spacedim>
     void
     build_cell_tables(std::vector< std::pair< std::pair< unsigned int, unsigned int >, unsigned int > > &system_to_base_table,
@@ -762,6 +769,8 @@ namespace FETools
           }
     }
 
+
+
     template <int dim, int spacedim>
     void
     build_face_tables(std::vector< std::pair< std::pair< unsigned int, unsigned int >, unsigned int > > &face_system_to_base_table,
@@ -922,6 +931,7 @@ namespace FETools
   }
 
 
+
   // Not implemented in the general case.
   template <class FE>
   FiniteElement<FE::dimension, FE::space_dimension> *
@@ -938,12 +948,14 @@ namespace FETools
   {
     return new FE_Q<1>(quad);
   }
+
   template <>
   FiniteElement<2, 2> *
   FEFactory<FE_Q<2, 2> >::get (const Quadrature<1> &quad) const
   {
     return new FE_Q<2>(quad);
   }
+
   template <>
   FiniteElement<3, 3> *
   FEFactory<FE_Q<3, 3> >::get (const Quadrature<1> &quad) const
@@ -958,12 +970,14 @@ namespace FETools
   {
     return new FE_Q_DG0<1>(quad);
   }
+
   template <>
   FiniteElement<2, 2> *
   FEFactory<FE_Q_DG0<2, 2> >::get (const Quadrature<1> &quad) const
   {
     return new FE_Q_DG0<2>(quad);
   }
+
   template <>
   FiniteElement<3, 3> *
   FEFactory<FE_Q_DG0<3, 3> >::get (const Quadrature<1> &quad) const
@@ -978,12 +992,14 @@ namespace FETools
   {
     return new FE_Q_Bubbles<1>(quad);
   }
+
   template <>
   FiniteElement<2, 2> *
   FEFactory<FE_Q_Bubbles<2, 2> >::get (const Quadrature<1> &quad) const
   {
     return new FE_Q_Bubbles<2>(quad);
   }
+
   template <>
   FiniteElement<3, 3> *
   FEFactory<FE_Q_Bubbles<3, 3> >::get (const Quadrature<1> &quad) const
@@ -991,7 +1007,6 @@ namespace FETools
     return new FE_Q_Bubbles<3>(quad);
   }
 
-
   // Specializations for FE_DGQArbitraryNodes.
   template <>
   FiniteElement<1, 1> *
@@ -999,24 +1014,28 @@ namespace FETools
   {
     return new FE_DGQArbitraryNodes<1>(quad);
   }
+
   template <>
   FiniteElement<1, 2> *
   FEFactory<FE_DGQ<1, 2> >::get (const Quadrature<1> &quad) const
   {
     return new FE_DGQArbitraryNodes<1, 2>(quad);
   }
+
   template <>
   FiniteElement<1, 3> *
   FEFactory<FE_DGQ<1, 3> >::get (const Quadrature<1> &quad) const
   {
     return new FE_DGQArbitraryNodes<1, 3>(quad);
   }
+
   template <>
   FiniteElement<2, 2> *
   FEFactory<FE_DGQ<2> >::get (const Quadrature<1> &quad) const
   {
     return new FE_DGQArbitraryNodes<2>(quad);
   }
+
   template <>
   FiniteElement<2, 3> *
   FEFactory<FE_DGQ<2, 3> >::get (const Quadrature<1> &quad) const
@@ -1094,6 +1113,8 @@ namespace
       = FEFactoryPointer(new FETools::FEFactory<FE_RannacherTurek<dim> >);
   }
 
+
+
   // This function fills a map from names to finite elements for any
   // dimension and codimension for those elements which support
   // nonzero codimension.
@@ -1222,6 +1243,7 @@ namespace
   }
 
 
+
   template <int dim, typename number, int spacedim>
   inline
   void gim_forwarder (const FiniteElement<dim,spacedim> &fe1,
@@ -1290,6 +1312,7 @@ namespace FETools
   {}
 
 
+
   template<int dim, int spacedim>
   void compute_component_wise(
     const FiniteElement<dim,spacedim> &element,
@@ -1579,6 +1602,7 @@ namespace FETools
   }
 
 
+
   template<int dim, int spacedim>
   void
   compute_node_matrix(
@@ -1714,6 +1738,7 @@ namespace FETools
     }
 
 
+
     template<int dim, typename number, int spacedim>
     void
     compute_embedding_matrices_for_refinement_case (
@@ -1837,6 +1862,7 @@ namespace FETools
   }
 
 
+
   template <int dim, typename number, int spacedim>
   void
   compute_embedding_matrices(const FiniteElement<dim,spacedim> &fe,
@@ -2618,6 +2644,7 @@ namespace FETools
   }
 
 
+
   template <int dim>
   FiniteElement<dim> *
   get_fe_by_name (const std::string &parameter_name)
@@ -2626,6 +2653,7 @@ namespace FETools
   }
 
 
+
   template <int dim, int spacedim>
   void
 
@@ -3066,6 +3094,8 @@ namespace FETools
     return (h2l);
   }
 
+
+
   template <int dim>
   void
   lexicographic_to_hierarchic_numbering (const FiniteElementData<dim> &fe,

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.