From: Daniel Arndt Date: Sun, 24 Jul 2016 13:10:54 +0000 (+0200) Subject: Adjust empty lines between functions in fe_tools.cc X-Git-Tag: v8.5.0-rc1~851^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=215ae5e1e6896c1f049320d08208b395a145052c;p=dealii.git Adjust empty lines between functions in fe_tools.cc --- diff --git a/source/fe/fe_tools.cc b/source/fe/fe_tools.cc index 3a78c29aec..7412d6a9f0 100644 --- a/source/fe/fe_tools.cc +++ b/source/fe/fe_tools.cc @@ -151,6 +151,8 @@ namespace FETools block_indices); } + + template FiniteElementData multiply_dof_numbers (const FiniteElement *fe1, @@ -180,6 +182,8 @@ namespace FETools return multiply_dof_numbers(fes, mult); } + + template std::vector compute_restriction_is_additive_flags (const std::vector*> &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 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 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 FiniteElement * @@ -938,12 +948,14 @@ namespace FETools { return new FE_Q<1>(quad); } + template <> FiniteElement<2, 2> * FEFactory >::get (const Quadrature<1> &quad) const { return new FE_Q<2>(quad); } + template <> FiniteElement<3, 3> * FEFactory >::get (const Quadrature<1> &quad) const @@ -958,12 +970,14 @@ namespace FETools { return new FE_Q_DG0<1>(quad); } + template <> FiniteElement<2, 2> * FEFactory >::get (const Quadrature<1> &quad) const { return new FE_Q_DG0<2>(quad); } + template <> FiniteElement<3, 3> * FEFactory >::get (const Quadrature<1> &quad) const @@ -978,12 +992,14 @@ namespace FETools { return new FE_Q_Bubbles<1>(quad); } + template <> FiniteElement<2, 2> * FEFactory >::get (const Quadrature<1> &quad) const { return new FE_Q_Bubbles<2>(quad); } + template <> FiniteElement<3, 3> * FEFactory >::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 >::get (const Quadrature<1> &quad) const { return new FE_DGQArbitraryNodes<1, 2>(quad); } + template <> FiniteElement<1, 3> * FEFactory >::get (const Quadrature<1> &quad) const { return new FE_DGQArbitraryNodes<1, 3>(quad); } + template <> FiniteElement<2, 2> * FEFactory >::get (const Quadrature<1> &quad) const { return new FE_DGQArbitraryNodes<2>(quad); } + template <> FiniteElement<2, 3> * FEFactory >::get (const Quadrature<1> &quad) const @@ -1094,6 +1113,8 @@ namespace = FEFactoryPointer(new FETools::FEFactory >); } + + // 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 inline void gim_forwarder (const FiniteElement &fe1, @@ -1290,6 +1312,7 @@ namespace FETools {} + template void compute_component_wise( const FiniteElement &element, @@ -1579,6 +1602,7 @@ namespace FETools } + template void compute_node_matrix( @@ -1714,6 +1738,7 @@ namespace FETools } + template void compute_embedding_matrices_for_refinement_case ( @@ -1837,6 +1862,7 @@ namespace FETools } + template void compute_embedding_matrices(const FiniteElement &fe, @@ -2618,6 +2644,7 @@ namespace FETools } + template FiniteElement * get_fe_by_name (const std::string ¶meter_name) @@ -2626,6 +2653,7 @@ namespace FETools } + template void @@ -3066,6 +3094,8 @@ namespace FETools return (h2l); } + + template void lexicographic_to_hierarchic_numbering (const FiniteElementData &fe,