]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Add a missing argument to a function.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Wed, 25 May 2016 18:00:31 +0000 (13:00 -0500)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Wed, 25 May 2016 18:00:31 +0000 (13:00 -0500)
include/deal.II/fe/fe_tools.h
source/fe/fe_tools.cc
source/fe/fe_tools.inst.in

index 9dba8de61e652f6f54506bd8222552bae631508c..dec736768afdea16ac95a160af9510da708b43f7 100644 (file)
@@ -1021,6 +1021,17 @@ namespace FETools
      * that the pointers indicate the elements to be composed, and the
      * arguments @p N1, @p N2, ... the multiplicities. Null pointers
      * indicate that an argument is to be skipped.
+     *
+     * If @p do_tensor_product is true, the number of components (and
+     * thus the size of the ComponentMask objects) is the sum over the
+     * product of the number of components in each of the finite
+     * elements times the corresponding multiplicity.  Otherwise the
+     * number of components is taken from the first finite element with
+     * non-zero multiplicity, and all other elements with non-zero
+     * multiplicities need to have the same number of vector components.
+     *
+     * See the documentation of namespace FETools::Compositing for more
+     * information about the @p do_tensor_product argument.
      */
     template <int dim, int spacedim>
     std::vector<ComponentMask>
@@ -1033,7 +1044,8 @@ namespace FETools
                                 const FiniteElement<dim,spacedim> *fe4=NULL,
                                 const unsigned int        N4=0,
                                 const FiniteElement<dim,spacedim> *fe5=NULL,
-                                const unsigned int        N5=0);
+                                const unsigned int        N5=0,
+                                const bool do_tensor_product = true);
 
     /**
      * For a given (composite) @p finite_element build @p
index 4c5922b10159c5c88f166abe72274d63d78a4dc3..95cd4080c0d70c427594adfe87028fdb9cfd8275 100644 (file)
@@ -538,7 +538,8 @@ namespace FETools
                                 const FiniteElement<dim,spacedim> *fe4,
                                 const unsigned int        N4,
                                 const FiniteElement<dim,spacedim> *fe5,
-                                const unsigned int        N5)
+                                const unsigned int        N5,
+                                const bool               do_tensor_product)
     {
       std::vector<const FiniteElement<dim,spacedim>*> fe_list;
       std::vector<unsigned int>              multiplicities;
@@ -558,7 +559,8 @@ namespace FETools
       fe_list.push_back (fe5);
       multiplicities.push_back (N5);
 
-      return compute_nonzero_components (fe_list, multiplicities);
+      return compute_nonzero_components (fe_list, multiplicities,
+                                         do_tensor_product);
     }
 
     template <int dim, int spacedim>
index c45db192130b3ff87135ef2efdb7a4c27f0b9efd..b87a95e25fb55a39ee15ac8a1f59369a0e4f6221 100644 (file)
@@ -75,7 +75,8 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
                                     const FiniteElement<deal_II_dimension,deal_II_space_dimension> *fe4,
                                     const unsigned int        N4,
                                     const FiniteElement<deal_II_dimension,deal_II_space_dimension> *fe5,
-                                    const unsigned int        N5);
+                                    const unsigned int        N5,
+                                    const bool);
 
          template
          void

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.