]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Change all uses of MappingType and mapping_type to MappingKind and mapping_kind 8472/head
authorgrahambenharper <grahambenharper@gmail.com>
Tue, 6 Aug 2019 21:06:09 +0000 (15:06 -0600)
committergrahambenharper <grahambenharper@gmail.com>
Wed, 7 Aug 2019 22:53:12 +0000 (16:53 -0600)
27 files changed:
doc/news/changes/incompatibilities/20190806GrahamHarper [new file with mode: 0644]
include/deal.II/fe/fe.h
include/deal.II/fe/fe_dg_vector.h
include/deal.II/fe/fe_dg_vector.templates.h
include/deal.II/fe/fe_nedelec_sz.h
include/deal.II/fe/fe_poly_tensor.h
include/deal.II/fe/mapping.h
include/deal.II/fe/mapping_cartesian.h
include/deal.II/fe/mapping_fe_field.h
include/deal.II/fe/mapping_manifold.h
include/deal.II/fe/mapping_q.h
include/deal.II/fe/mapping_q_generic.h
include/deal.II/numerics/vector_tools.templates.h
source/fe/fe_abf.cc
source/fe/fe_bdm.cc
source/fe/fe_bernardi_raugel.cc
source/fe/fe_nedelec.cc
source/fe/fe_nedelec_sz.cc
source/fe/fe_poly_tensor.cc
source/fe/fe_raviart_thomas.cc
source/fe/fe_raviart_thomas_nodal.cc
source/fe/fe_rt_bubbles.cc
source/fe/mapping_cartesian.cc
source/fe/mapping_fe_field.cc
source/fe/mapping_manifold.cc
source/fe/mapping_q.cc
source/fe/mapping_q_generic.cc

diff --git a/doc/news/changes/incompatibilities/20190806GrahamHarper b/doc/news/changes/incompatibilities/20190806GrahamHarper
new file mode 100644 (file)
index 0000000..659c91b
--- /dev/null
@@ -0,0 +1,7 @@
+Changed: mapping.h referred to different kinds of mappings in an enum 
+MappingType; however, since it's an enum, MappingType is a misleading name. 
+All instances of MappingType and mapping_type have been changed to 
+MappingKind and mapping_kind, respectively. The documentation has been 
+updated in order to reflect these changes as well.
+<br>
+(Graham Harper, 2019/08/06)
index cba00c07c33334ea631d332a6921e0c73ee22e12..583e233a79ccb865d042ab7e60aaef9b001e326e 100644 (file)
@@ -2289,7 +2289,7 @@ public:
    *   the node functionals of the element applied to the given function.
    *
    * @note It is safe to call this function for (transformed) values on the
-   * real cell only for elements with trivial MappingType. For all other
+   * real cell only for elements with trivial MappingKind. For all other
    * elements (for example for H(curl), or H(div) conforming elements)
    * vector values have to be transformed to the reference cell first.
    *
index dcd25333fe85edb56e16a75f74f30b22d1c8796f..9e0ff6eee7a3fe44f540a335e6ee66b9adb00be5 100644 (file)
@@ -58,7 +58,7 @@ public:
   /**
    * Constructor for the vector element of degree @p p.
    */
-  FE_DGVector(const unsigned int p, MappingType m);
+  FE_DGVector(const unsigned int p, MappingKind m);
 
   /**
    * Return a string that uniquely identifies a finite element. This class
index a0893d2e47ef324e6d9eb334d4c58d4b7b51e66b..05c0622a994bed584587b8c44784fa3a7ec2d757 100644 (file)
@@ -32,7 +32,7 @@ DEAL_II_NAMESPACE_OPEN
 
 template <class PolynomialType, int dim, int spacedim>
 FE_DGVector<PolynomialType, dim, spacedim>::FE_DGVector(const unsigned int deg,
-                                                        MappingType        map)
+                                                        MappingKind        map)
   : FE_PolyTensor<PolynomialType, dim, spacedim>(
       deg,
       FiniteElementData<dim>(get_dpo_vector(deg),
@@ -43,7 +43,7 @@ FE_DGVector<PolynomialType, dim, spacedim>::FE_DGVector(const unsigned int deg,
       std::vector<ComponentMask>(PolynomialType::compute_n_pols(deg),
                                  ComponentMask(dim, true)))
 {
-  this->mapping_type                   = {map};
+  this->mapping_kind                   = {map};
   const unsigned int polynomial_degree = this->tensor_degree();
 
   QGauss<dim> quadrature(polynomial_degree + 1);
index 66e889b32314bd78be1403271667164a44b0312d..57de49d51f616e6947ede65ec927d3bc5f14f040 100644 (file)
@@ -137,7 +137,7 @@ public:
 
   /**
    * Given <tt>flags</tt>, determines the values which must be computed only
-   * for the reference cell. Make sure, that #mapping_type is set by the
+   * for the reference cell. Make sure, that #mapping_kind is set by the
    * derived class, such that this function can operate correctly.
    */
   UpdateFlags
@@ -145,7 +145,7 @@ public:
 
   /**
    * Given <tt>flags</tt>, determines the values which must be computed in
-   * each cell cell. Make sure, that #mapping_type is set by the derived
+   * each cell cell. Make sure, that #mapping_kind is set by the derived
    * class, such that this function can operate correctly.
    */
   UpdateFlags
@@ -153,10 +153,10 @@ public:
 
 protected:
   /**
-   * The mapping type to be used to map shape functions from the reference
+   * The mapping kind to be used to map shape functions from the reference
    * cell to the mesh cell.
    */
-  MappingType mapping_type;
+  MappingKind mapping_kind;
 
   virtual std::unique_ptr<
     typename dealii::FiniteElement<dim, spacedim>::InternalDataBase>
index 74718870d4163b6ac920575fe6af602851231da8..4010161cb58ca05b4170135084971e9511c8acd9 100644 (file)
@@ -62,7 +62,7 @@ DEAL_II_NAMESPACE_OPEN
  *
  * Similarly, in many cases, node functionals depend on the shape of the mesh
  * cell, since they evaluate normal or tangential components on the faces. In
- * order to allow for a set of transformations, the variable #mapping_type has
+ * order to allow for a set of transformations, the variable #mapping_kind has
  * been introduced. It should needs be set in the constructor of a derived
  * class.
  *
@@ -126,15 +126,15 @@ DEAL_II_NAMESPACE_OPEN
  *
  * In most cases, vector valued basis functions must be transformed when
  * mapped from the reference cell to the actual grid cell. These
- * transformations can be selected from the set MappingType and stored in
- * #mapping_type. Therefore, each constructor should contain a line like:
+ * transformations can be selected from the set MappingKind and stored in
+ * #mapping_kind. Therefore, each constructor should contain a line like:
  * @code
- * this->mapping_type = {mapping_none};
+ * this->mapping_kind = {mapping_none};
  * @endcode
  * (in case no mapping is required) or using whatever value among
- * the ones defined in MappingType is appropriate for the element you
+ * the ones defined in MappingKind is appropriate for the element you
  * are implementing. If each shape function may be mapped by different
- * mappings, then @p mapping_type may be a vector with the same number
+ * mappings, then @p mapping_kind may be a vector with the same number
  * of elements as there are shape functions.
  *
  * @see PolynomialsBDM, PolynomialsRaviartThomas
@@ -214,20 +214,20 @@ protected:
    * the finite element dofs per cell, then each shape function will be mapped
    * according to the corresponding entry in the vector.
    */
-  std::vector<MappingType> mapping_type;
+  std::vector<MappingKind> mapping_kind;
 
   /**
    * Returns a boolean that is true when the finite element uses a single
    * mapping and false when the finite element uses multiple mappings.
    */
   bool
-  single_mapping_type() const;
+  single_mapping_kind() const;
 
   /**
-   * Returns MappingType @p i for the finite element.
+   * Returns MappingKind @p i for the finite element.
    */
-  MappingType
-  get_mapping_type(const unsigned int i) const;
+  MappingKind
+  get_mapping_kind(const unsigned int i) const;
 
   /* NOTE: The following function has its definition inlined into the class
      declaration because we otherwise run into a compiler error with MS Visual
@@ -266,14 +266,14 @@ protected:
     // allocate memory
 
     const bool update_transformed_shape_values =
-      std::any_of(this->mapping_type.begin(),
-                  this->mapping_type.end(),
-                  [](const MappingType t) { return t != mapping_none; });
+      std::any_of(this->mapping_kind.begin(),
+                  this->mapping_kind.end(),
+                  [](const MappingKind t) { return t != mapping_none; });
 
     const bool update_transformed_shape_grads =
-      std::any_of(this->mapping_type.begin(),
-                  this->mapping_type.end(),
-                  [](const MappingType t) {
+      std::any_of(this->mapping_kind.begin(),
+                  this->mapping_kind.end(),
+                  [](const MappingKind t) {
                     return (t == mapping_raviart_thomas || t == mapping_piola ||
                             t == mapping_nedelec || t == mapping_contravariant);
                   });
index 2025514d2a4fddb44f78ca7d69eff244fe909a06..7fc1f675dbca369813da584c8d3f8745ec090194 100644 (file)
@@ -48,7 +48,7 @@ class FESubfaceValues;
 
 
 /**
- * The transformation type used for the Mapping::transform() functions.
+ * The transformation kind used for the Mapping::transform() functions.
  *
  * Special finite elements may need special Mapping from the reference cell to
  * the actual mesh cell. In order to be most flexible, this enum provides an
@@ -58,7 +58,7 @@ class FESubfaceValues;
  *
  * @ingroup mapping
  */
-enum MappingType
+enum MappingKind
 {
   /**
    * No mapping, i.e., shape functions are not mapped from a reference cell
@@ -106,7 +106,7 @@ enum MappingType
    * The mapping used for Nedelec elements.
    *
    * Curl-conforming elements are mapped as covariant vectors. Nevertheless,
-   * we introduce a separate mapping type, such that we can use the same flag
+   * we introduce a separate mapping kind, such that we can use the same flag
    * for the vector and its gradient (see Mapping::transform() for details).
    */
   mapping_nedelec = 0x0200,
@@ -229,7 +229,7 @@ enum MappingType
  * The differential forms <b>A</b> and <b>B</b> are determined by the kind of
  * object being transformed. These transformations are performed through the
  * transform() functions, and the type of object being transformed is
- * specified by their MappingType argument. See the documentation there for
+ * specified by their MappingKind argument. See the documentation there for
  * possible choices.
  *
  * <h4>Derivatives of the mapping</h4>
@@ -950,14 +950,14 @@ public:
 
   /**
    * Transform a field of vectors or 1-differential forms according to the
-   * selected MappingType.
+   * selected MappingKind.
    *
    * @note Normally, this function is called by a finite element, filling
    * FEValues objects. For this finite element, there should be an alias
-   * MappingType like @p mapping_bdm, @p mapping_nedelec, etc. This alias
-   * should be preferred to using the types below.
+   * MappingKind like @p mapping_bdm, @p mapping_nedelec, etc. This alias
+   * should be preferred to using the kinds below.
    *
-   * The mapping types currently implemented by derived classes are:
+   * The mapping kinds currently implemented by derived classes are:
    * <ul>
    * <li> @p mapping_contravariant: maps a vector field on the reference cell
    * to the physical cell through the Jacobian:
@@ -998,7 +998,7 @@ public:
    *
    * @param[in] input An array (or part of an array) of input objects that
    * should be mapped.
-   * @param[in] type The kind of mapping to be applied.
+   * @param[in] kind The kind of mapping to be applied.
    * @param[in] internal A pointer to an object of type
    * Mapping::InternalDataBase that contains information previously stored by
    * the mapping. The object pointed to was created by the get_data(),
@@ -1013,7 +1013,7 @@ public:
    */
   virtual void
   transform(const ArrayView<const Tensor<1, dim>> &                  input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<1, spacedim>> &output) const = 0;
 
@@ -1021,7 +1021,7 @@ public:
    * Transform a field of differential forms from the reference cell to the
    * physical cell.  It is useful to think of $\mathbf{T} = \nabla \mathbf u$
    * and $\hat{\mathbf  T} = \hat \nabla \hat{\mathbf  u}$, with $\mathbf u$ a
-   * vector field.  The mapping types currently implemented by derived classes
+   * vector field.  The mapping kinds currently implemented by derived classes
    * are:
    * <ul>
    * <li> @p mapping_covariant: maps a field of forms on the reference cell to
@@ -1051,7 +1051,7 @@ public:
    *
    * @param[in] input An array (or part of an array) of input objects that
    * should be mapped.
-   * @param[in] type The kind of mapping to be applied.
+   * @param[in] kind The kind of mapping to be applied.
    * @param[in] internal A pointer to an object of type
    * Mapping::InternalDataBase that contains information previously stored by
    * the mapping. The object pointed to was created by the get_data(),
@@ -1066,7 +1066,7 @@ public:
    */
   virtual void
   transform(const ArrayView<const DerivativeForm<1, dim, spacedim>> &input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<2, spacedim>> &output) const = 0;
 
@@ -1074,7 +1074,7 @@ public:
    * Transform a tensor field from the reference cell to the physical cell.
    * These tensors are usually the Jacobians in the reference cell of vector
    * fields that have been pulled back from the physical cell.  The mapping
-   * types currently implemented by derived classes are:
+   * kinds currently implemented by derived classes are:
    * <ul>
    * <li> @p mapping_contravariant_gradient: it assumes $\mathbf u(\mathbf x)
    * = J \hat{\mathbf  u}$ so that
@@ -1109,7 +1109,7 @@ public:
    *
    * @param[in] input An array (or part of an array) of input objects that
    * should be mapped.
-   * @param[in] type The kind of mapping to be applied.
+   * @param[in] kind The kind of mapping to be applied.
    * @param[in] internal A pointer to an object of type
    * Mapping::InternalDataBase that contains information previously stored by
    * the mapping. The object pointed to was created by the get_data(),
@@ -1124,7 +1124,7 @@ public:
    */
   virtual void
   transform(const ArrayView<const Tensor<2, dim>> &                  input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<2, spacedim>> &output) const = 0;
 
@@ -1133,7 +1133,7 @@ public:
    * This tensors are most of times the hessians in the reference cell of
    * vector fields that have been pulled back from the physical cell.
    *
-   * The mapping types currently implemented by derived classes are:
+   * The mapping kinds currently implemented by derived classes are:
    * <ul>
    * <li> @p mapping_covariant_gradient: maps a field of forms on the
    * reference cell to a field of forms on the physical cell. Mathematically,
@@ -1156,7 +1156,7 @@ public:
    *
    * @param[in] input An array (or part of an array) of input objects that
    * should be mapped.
-   * @param[in] type The kind of mapping to be applied.
+   * @param[in] kind The kind of mapping to be applied.
    * @param[in] internal A pointer to an object of type
    * Mapping::InternalDataBase that contains information previously stored by
    * the mapping. The object pointed to was created by the get_data(),
@@ -1171,7 +1171,7 @@ public:
    */
   virtual void
   transform(const ArrayView<const DerivativeForm<2, dim, spacedim>> &input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<3, spacedim>> &output) const = 0;
 
@@ -1181,7 +1181,7 @@ public:
    * \mathbf u_i$ and $\mathbf{\hat T}_{IJK} = \hat D^2_{JK} \mathbf{\hat
    * u}_I$, with $\mathbf u_i$ a vector field.
    *
-   * The mapping types currently implemented by derived classes are:
+   * The mapping kinds currently implemented by derived classes are:
    * <ul>
    * <li> @p mapping_contravariant_hessian: it assumes $\mathbf u_i(\mathbf x)
    * = J_{iI} \hat{\mathbf  u}_I$ so that
@@ -1210,7 +1210,7 @@ public:
    *
    * @param[in] input An array (or part of an array) of input objects that
    * should be mapped.
-   * @param[in] type The kind of mapping to be applied.
+   * @param[in] kind The kind of mapping to be applied.
    * @param[in] internal A pointer to an object of type
    * Mapping::InternalDataBase that contains information previously stored by
    * the mapping. The object pointed to was created by the get_data(),
@@ -1224,7 +1224,7 @@ public:
    */
   virtual void
   transform(const ArrayView<const Tensor<3, dim>> &                  input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<3, spacedim>> &output) const = 0;
 
index c0680b50c086b28baca0ab3df03f5adc98b9d101..2e507b3ac8bb7c8144267a26df734f389d4c72d4 100644 (file)
@@ -101,35 +101,35 @@ public:
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const Tensor<1, dim>> &                  input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<1, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const DerivativeForm<1, dim, spacedim>> &input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<2, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const Tensor<2, dim>> &                  input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<2, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const DerivativeForm<2, dim, spacedim>> &input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<3, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const Tensor<3, dim>> &                  input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<3, spacedim>> &output) const override;
 
index 19e62ae5069609a3c698f988506813f0d41c7245..b4d5d5ead196a636c0727a350fee6d27ddcfdc66 100644 (file)
@@ -204,35 +204,35 @@ public:
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const Tensor<1, dim>> &                  input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<1, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const DerivativeForm<1, dim, spacedim>> &input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<2, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const Tensor<2, dim>> &                  input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<2, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const DerivativeForm<2, dim, spacedim>> &input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<3, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const Tensor<3, dim>> &                  input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<3, spacedim>> &output) const override;
 
index 0ceee849bace52592e0c2c6eecaad39452b19f9b..b2911598ac568bfeb83d290e4f748f5e82eb2449 100644 (file)
@@ -110,35 +110,35 @@ public:
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const Tensor<1, dim>> &                  input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<1, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const DerivativeForm<1, dim, spacedim>> &input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<2, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const Tensor<2, dim>> &                  input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<2, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const DerivativeForm<2, dim, spacedim>> &input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<3, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const Tensor<3, dim>> &                  input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<3, spacedim>> &output) const override;
 
index c409e6ec15ae19617140612cea732522cac7e366..33dd1de1d899a7bac00f749efcf084f583ce2ce1 100644 (file)
@@ -160,35 +160,35 @@ public:
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const Tensor<1, dim>> &                  input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<1, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const DerivativeForm<1, dim, spacedim>> &input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<2, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const Tensor<2, dim>> &                  input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<2, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const DerivativeForm<2, dim, spacedim>> &input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<3, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const Tensor<3, dim>> &                  input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<3, spacedim>> &output) const override;
 
index 8932a2db54c4ac9c3a2efa64d392a9a722c1f38d..f4669f6d3359e877236496fcfc5d897be24cb12e 100644 (file)
@@ -195,35 +195,35 @@ public:
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const Tensor<1, dim>> &                  input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<1, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const DerivativeForm<1, dim, spacedim>> &input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<2, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const Tensor<2, dim>> &                  input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<2, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const DerivativeForm<2, dim, spacedim>> &input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<3, spacedim>> &output) const override;
 
   // for documentation, see the Mapping base class
   virtual void
   transform(const ArrayView<const Tensor<3, dim>> &                  input,
-            const MappingType                                        type,
+            const MappingKind                                        kind,
             const typename Mapping<dim, spacedim>::InternalDataBase &internal,
             const ArrayView<Tensor<3, spacedim>> &output) const override;
 
index be663b841b029164a5525132a1d23f0b3ecc9fa2..fb16cd82e8cbe509f3572e9d4184b9ff0c1e2639 100644 (file)
@@ -111,7 +111,7 @@ namespace VectorTools
     // FIXME: This should be refactored into the mapping (i.e.
     // implement the inverse function of Mapping<dim, spacedim>::transform).
     // Further, the finite element should make the information about
-    // the correct mapping directly accessible (i.e. which MappingType
+    // the correct mapping directly accessible (i.e. which MappingKind
     // should be used). Using fe.conforming_space might be a bit of a
     // problem because we only support doing nothing, Hcurl, and Hdiv
     // conforming mappings.
index 229344046fd913430593398cf3f82f3e01f478bc..df9e67520f5eb81883d26769bd67dee9c52f71a8 100644 (file)
@@ -60,7 +60,7 @@ FE_ABF<dim>::FE_ABF(const unsigned int deg)
   Assert(dim >= 2, ExcImpossibleInDim(dim));
   const unsigned int n_dofs = this->dofs_per_cell;
 
-  this->mapping_type = {mapping_raviart_thomas};
+  this->mapping_kind = {mapping_raviart_thomas};
   // First, initialize the
   // generalized support points and
   // quadrature weights, since they
index 0dfd5374f6773ef2a043220879be1c8e82e73bbf..63bbd947e01f35a40b0dd6d38f386c4595992ed0 100644 (file)
@@ -56,7 +56,7 @@ FE_BDM<dim>::FE_BDM(const unsigned int deg)
 
   const unsigned int n_dofs = this->dofs_per_cell;
 
-  this->mapping_type = {mapping_bdm};
+  this->mapping_kind = {mapping_bdm};
   // These must be done first, since
   // they change the evaluation of
   // basis functions
index 58932f188f8a8950058bcf1521f9b093215f869b..6e30098e84f49d34d061291cbd444f229806b452 100644 (file)
@@ -55,7 +55,7 @@ FE_BernardiRaugel<dim>::FE_BernardiRaugel(const unsigned int p)
 
   // const unsigned int n_dofs = this->dofs_per_cell;
 
-  this->mapping_type = {mapping_none};
+  this->mapping_kind = {mapping_none};
   // These must be done first, since
   // they change the evaluation of
   // basis functions
index ad175ac7084c32cec514071f5f977c9c0c42f284..81ce3afe431c4bde5f5ee01515a0721fd226e2d8 100644 (file)
@@ -87,7 +87,7 @@ FE_Nedelec<dim>::FE_Nedelec(const unsigned int order)
 
   const unsigned int n_dofs = this->dofs_per_cell;
 
-  this->mapping_type = {mapping_nedelec};
+  this->mapping_kind = {mapping_nedelec};
   // First, initialize the
   // generalized support points and
   // quadrature weights, since they
index b455041a35ae8e4648215b305876b013df43cbf6..b60fdc07c1c322b443baaa57f5e077693b8192b2 100644 (file)
@@ -33,7 +33,7 @@ FE_NedelecSZ<dim, spacedim>::FE_NedelecSZ(const unsigned int degree)
 {
   Assert(dim >= 2, ExcImpossibleInDim(dim));
 
-  this->mapping_type = mapping_nedelec;
+  this->mapping_kind = mapping_nedelec;
   // Set up the table converting components to base components. Since we have
   // only one base element, everything remains zero except the component in the
   // base, which is the component itself.
@@ -2170,7 +2170,7 @@ template <int dim, int spacedim>
 UpdateFlags
 FE_NedelecSZ<dim, spacedim>::update_once(const UpdateFlags flags) const
 {
-  const bool values_once = (mapping_type == mapping_none);
+  const bool values_once = (mapping_kind == mapping_none);
 
   UpdateFlags out = update_default;
   if (values_once && (flags & update_values))
index 1a9cc43a18803f9d4019645c0c4de92c435a47ac..2cb944c3861cb6650c2bf60f8afe44d4af1a999f 100644 (file)
@@ -53,7 +53,7 @@ namespace internal
       void
       get_face_sign_change_rt(const dealii::Triangulation<1>::cell_iterator &,
                               const FiniteElement<1, spacedim> &,
-                              const std::vector<MappingType> &,
+                              const std::vector<MappingKind> &,
                               std::vector<double> &)
       {
         // nothing to do in 1d
@@ -66,7 +66,7 @@ namespace internal
       get_face_sign_change_rt(
         const dealii::Triangulation<2>::cell_iterator &cell,
         const FiniteElement<2, 2> &                    fe,
-        const std::vector<MappingType> &               mapping_type,
+        const std::vector<MappingKind> &               mapping_kind,
         std::vector<double> &                          face_sign)
       {
         const unsigned int dim      = 2;
@@ -89,15 +89,15 @@ namespace internal
 
                       Assert(f * fe.dofs_per_face + j < face_sign.size(),
                              ExcInternalError());
-                      Assert(mapping_type.size() == 1 ||
-                               cell_j < mapping_type.size(),
+                      Assert(mapping_kind.size() == 1 ||
+                               cell_j < mapping_kind.size(),
                              ExcInternalError());
 
                       // TODO: This is probably only going to work for those
                       // elements for which all dofs are face dofs
-                      if ((mapping_type.size() > 1 ?
-                             mapping_type[cell_j] :
-                             mapping_type[0]) == mapping_raviart_thomas)
+                      if ((mapping_kind.size() > 1 ?
+                             mapping_kind[cell_j] :
+                             mapping_kind[0]) == mapping_raviart_thomas)
                         face_sign[f * fe.dofs_per_face + j] = -1.0;
                     }
               }
@@ -111,7 +111,7 @@ namespace internal
       get_face_sign_change_rt(
         const dealii::Triangulation<3>::cell_iterator & /*cell*/,
         const FiniteElement<3, spacedim> & /*fe*/,
-        const std::vector<MappingType> & /*mapping_type*/,
+        const std::vector<MappingKind> & /*mapping_kind*/,
         std::vector<double> & /*face_sign*/)
       {
         // TODO: think about what it would take here
@@ -124,7 +124,7 @@ namespace internal
       get_face_sign_change_nedelec(
         const dealii::Triangulation<1>::cell_iterator & /*cell*/,
         const FiniteElement<1, spacedim> & /*fe*/,
-        const std::vector<MappingType> & /*mapping_type*/,
+        const std::vector<MappingKind> & /*mapping_kind*/,
         std::vector<double> & /*face_sign*/)
       {
         // nothing to do in 1d
@@ -137,7 +137,7 @@ namespace internal
       get_face_sign_change_nedelec(
         const dealii::Triangulation<2>::cell_iterator & /*cell*/,
         const FiniteElement<2, spacedim> & /*fe*/,
-        const std::vector<MappingType> & /*mapping_type*/,
+        const std::vector<MappingKind> & /*mapping_kind*/,
         std::vector<double> & /*face_sign*/)
       {
         // TODO: think about what it would take here
@@ -149,7 +149,7 @@ namespace internal
       get_face_sign_change_nedelec(
         const dealii::Triangulation<3>::cell_iterator &cell,
         const FiniteElement<3, spacedim> & /*fe*/,
-        const std::vector<MappingType> &mapping_type,
+        const std::vector<MappingKind> &mapping_kind,
         std::vector<double> &           face_sign)
       {
         const unsigned int dim = 3;
@@ -157,7 +157,7 @@ namespace internal
         // which all dofs are face dofs
         for (unsigned int l = 0; l < GeometryInfo<dim>::lines_per_cell; ++l)
           if (!(cell->line_orientation(l)) &&
-              mapping_type[0] == mapping_nedelec)
+              mapping_kind[0] == mapping_nedelec)
             face_sign[l] = -1.0;
       }
     } // namespace
@@ -175,7 +175,7 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::FE_PolyTensor(
   : FiniteElement<dim, spacedim>(fe_data,
                                  restriction_is_additive_flags,
                                  nonzero_components)
-  , mapping_type({MappingType::mapping_none})
+  , mapping_kind({MappingKind::mapping_none})
   , poly_space(PolynomialType(degree))
 {
   cached_point(0) = -1;
@@ -194,23 +194,23 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::FE_PolyTensor(
 
 template <class PolynomialType, int dim, int spacedim>
 bool
-FE_PolyTensor<PolynomialType, dim, spacedim>::single_mapping_type() const
+FE_PolyTensor<PolynomialType, dim, spacedim>::single_mapping_kind() const
 {
-  return mapping_type.size() == 1;
+  return mapping_kind.size() == 1;
 }
 
 
 
 template <class PolynomialType, int dim, int spacedim>
-MappingType
-FE_PolyTensor<PolynomialType, dim, spacedim>::get_mapping_type(
+MappingKind
+FE_PolyTensor<PolynomialType, dim, spacedim>::get_mapping_kind(
   const unsigned int i) const
 {
-  if (single_mapping_type())
-    return mapping_type[0];
+  if (single_mapping_kind())
+    return mapping_kind[0];
 
-  Assert(i < mapping_type.size(), ExcIndexRange(i, 0, mapping_type.size()));
-  return mapping_type[i];
+  Assert(i < mapping_kind.size(), ExcIndexRange(i, 0, mapping_kind.size()));
+  return mapping_kind[i];
 }
 
 
@@ -403,18 +403,18 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::fill_fe_values(
 
   internal::FE_PolyTensor::get_face_sign_change_rt(cell,
                                                    *this,
-                                                   this->mapping_type,
+                                                   this->mapping_kind,
                                                    fe_data.sign_change);
 
   internal::FE_PolyTensor::get_face_sign_change_nedelec(cell,
                                                         *this,
-                                                        this->mapping_type,
+                                                        this->mapping_kind,
                                                         fe_data.sign_change);
 
 
   for (unsigned int i = 0; i < this->dofs_per_cell; ++i)
     {
-      const MappingType mapping_type = get_mapping_type(i);
+      const MappingKind mapping_kind = get_mapping_kind(i);
 
       const unsigned int first =
         output_data.shape_function_to_row_table[i * this->n_components() +
@@ -429,11 +429,11 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::fill_fe_values(
       // and derivatives because of possible sign changes
       if (fe_data.update_each & update_values &&
           ((cell_similarity != CellSimilarity::translation) ||
-           ((mapping_type == mapping_piola) ||
-            (mapping_type == mapping_raviart_thomas) ||
-            (mapping_type == mapping_nedelec))))
+           ((mapping_kind == mapping_piola) ||
+            (mapping_kind == mapping_raviart_thomas) ||
+            (mapping_kind == mapping_nedelec))))
         {
-          switch (mapping_type)
+          switch (mapping_kind)
             {
               case mapping_none:
                 {
@@ -448,7 +448,7 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::fill_fe_values(
               case mapping_contravariant:
                 {
                   mapping.transform(make_array_view(fe_data.shape_values, i),
-                                    mapping_type,
+                                    mapping_kind,
                                     mapping_internal,
                                     make_array_view(
                                       fe_data.transformed_shape_values));
@@ -502,12 +502,12 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::fill_fe_values(
       // update gradients. apply the same logic as above
       if (fe_data.update_each & update_gradients &&
           ((cell_similarity != CellSimilarity::translation) ||
-           ((mapping_type == mapping_piola) ||
-            (mapping_type == mapping_raviart_thomas) ||
-            (mapping_type == mapping_nedelec))))
+           ((mapping_kind == mapping_piola) ||
+            (mapping_kind == mapping_raviart_thomas) ||
+            (mapping_kind == mapping_nedelec))))
 
         {
-          switch (mapping_type)
+          switch (mapping_kind)
             {
               case mapping_none:
                 {
@@ -647,12 +647,12 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::fill_fe_values(
       // update hessians. apply the same logic as above
       if (fe_data.update_each & update_hessians &&
           ((cell_similarity != CellSimilarity::translation) ||
-           ((mapping_type == mapping_piola) ||
-            (mapping_type == mapping_raviart_thomas) ||
-            (mapping_type == mapping_nedelec))))
+           ((mapping_kind == mapping_piola) ||
+            (mapping_kind == mapping_raviart_thomas) ||
+            (mapping_kind == mapping_nedelec))))
 
         {
-          switch (mapping_type)
+          switch (mapping_kind)
             {
               case mapping_none:
                 {
@@ -923,9 +923,9 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::fill_fe_values(
       // third derivatives are not implemented
       if (fe_data.update_each & update_3rd_derivatives &&
           ((cell_similarity != CellSimilarity::translation) ||
-           ((mapping_type == mapping_piola) ||
-            (mapping_type == mapping_raviart_thomas) ||
-            (mapping_type == mapping_nedelec))))
+           ((mapping_kind == mapping_piola) ||
+            (mapping_kind == mapping_raviart_thomas) ||
+            (mapping_kind == mapping_nedelec))))
         {
           Assert(false, ExcNotImplemented())
         }
@@ -982,17 +982,17 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::fill_fe_face_values(
 
   internal::FE_PolyTensor::get_face_sign_change_rt(cell,
                                                    *this,
-                                                   this->mapping_type,
+                                                   this->mapping_kind,
                                                    fe_data.sign_change);
 
   internal::FE_PolyTensor::get_face_sign_change_nedelec(cell,
                                                         *this,
-                                                        this->mapping_type,
+                                                        this->mapping_kind,
                                                         fe_data.sign_change);
 
   for (unsigned int i = 0; i < this->dofs_per_cell; ++i)
     {
-      const MappingType mapping_type = get_mapping_type(i);
+      const MappingKind mapping_kind = get_mapping_kind(i);
 
       const unsigned int first =
         output_data.shape_function_to_row_table[i * this->n_components() +
@@ -1001,7 +1001,7 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::fill_fe_face_values(
 
       if (fe_data.update_each & update_values)
         {
-          switch (mapping_type)
+          switch (mapping_kind)
             {
               case mapping_none:
                 {
@@ -1024,7 +1024,7 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::fill_fe_face_values(
                                                     i,
                                                     offset,
                                                     n_q_points),
-                                    mapping_type,
+                                    mapping_kind,
                                     mapping_internal,
                                     transformed_shape_values);
 
@@ -1087,7 +1087,7 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::fill_fe_face_values(
 
       if (fe_data.update_each & update_gradients)
         {
-          switch (mapping_type)
+          switch (mapping_kind)
             {
               case mapping_none:
                 {
@@ -1251,7 +1251,7 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::fill_fe_face_values(
 
       if (fe_data.update_each & update_hessians)
         {
-          switch (mapping_type)
+          switch (mapping_kind)
             {
               case mapping_none:
                 {
@@ -1598,8 +1598,8 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::fill_fe_subface_values(
                                                 n_q_points,
                                                 cell->subface_case(face_no));
 
-  //   Assert(mapping_type == independent
-  //       || ( mapping_type == independent_on_cartesian
+  //   Assert(mapping_kind == independent
+  //       || ( mapping_kind == independent_on_cartesian
   //            && dynamic_cast<const MappingCartesian<dim>*>(&mapping) != 0),
   //       ExcNotImplemented());
   // TODO: Size assertions
@@ -1612,17 +1612,17 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::fill_fe_subface_values(
 
   internal::FE_PolyTensor::get_face_sign_change_rt(cell,
                                                    *this,
-                                                   this->mapping_type,
+                                                   this->mapping_kind,
                                                    fe_data.sign_change);
 
   internal::FE_PolyTensor::get_face_sign_change_nedelec(cell,
                                                         *this,
-                                                        this->mapping_type,
+                                                        this->mapping_kind,
                                                         fe_data.sign_change);
 
   for (unsigned int i = 0; i < this->dofs_per_cell; ++i)
     {
-      const MappingType mapping_type = get_mapping_type(i);
+      const MappingKind mapping_kind = get_mapping_kind(i);
 
       const unsigned int first =
         output_data.shape_function_to_row_table[i * this->n_components() +
@@ -1631,7 +1631,7 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::fill_fe_subface_values(
 
       if (fe_data.update_each & update_values)
         {
-          switch (mapping_type)
+          switch (mapping_kind)
             {
               case mapping_none:
                 {
@@ -1654,7 +1654,7 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::fill_fe_subface_values(
                                                     i,
                                                     offset,
                                                     n_q_points),
-                                    mapping_type,
+                                    mapping_kind,
                                     mapping_internal,
                                     transformed_shape_values);
 
@@ -1724,7 +1724,7 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::fill_fe_subface_values(
             make_array_view(fe_data.transformed_shape_grads,
                             offset,
                             n_q_points);
-          switch (mapping_type)
+          switch (mapping_kind)
             {
               case mapping_none:
                 {
@@ -1870,7 +1870,7 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::fill_fe_subface_values(
 
       if (fe_data.update_each & update_hessians)
         {
-          switch (mapping_type)
+          switch (mapping_kind)
             {
               case mapping_none:
                 {
@@ -2186,9 +2186,9 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::requires_update_flags(
 
   for (unsigned int i = 0; i < this->dofs_per_cell; ++i)
     {
-      const MappingType mapping_type = get_mapping_type(i);
+      const MappingKind mapping_kind = get_mapping_kind(i);
 
-      switch (mapping_type)
+      switch (mapping_kind)
         {
           case mapping_none:
             {
index 0aead6d54e1ed104dca5d2e152ecb536dc96696a..022e33a9f44ae4abfa2de635071b1d2be288c5c1 100644 (file)
@@ -60,7 +60,7 @@ FE_RaviartThomas<dim>::FE_RaviartThomas(const unsigned int deg)
   Assert(dim >= 2, ExcImpossibleInDim(dim));
   const unsigned int n_dofs = this->dofs_per_cell;
 
-  this->mapping_type = {mapping_raviart_thomas};
+  this->mapping_kind = {mapping_raviart_thomas};
   // First, initialize the
   // generalized support points and
   // quadrature weights, since they
index a7f40dfc9847a16b9c96bef0f36775d1da68c4a9..0e6dc86d7c006bda660d5eabd413ce4591153875 100644 (file)
@@ -52,7 +52,7 @@ FE_RaviartThomasNodal<dim>::FE_RaviartThomasNodal(const unsigned int deg)
   Assert(dim >= 2, ExcImpossibleInDim(dim));
   const unsigned int n_dofs = this->dofs_per_cell;
 
-  this->mapping_type = {mapping_raviart_thomas};
+  this->mapping_kind = {mapping_raviart_thomas};
   // First, initialize the
   // generalized support points and
   // quadrature weights, since they
index a5ab697f275d70820c485686b6545d714c3f625a..74ad3afba43028f48b8fedf5fccfaf43035abd89 100644 (file)
@@ -55,7 +55,7 @@ FE_RT_Bubbles<dim>::FE_RT_Bubbles(const unsigned int deg)
       "Lowest order RT_Bubbles element is degree 1, but you requested for degree 0"));
   const unsigned int n_dofs = this->dofs_per_cell;
 
-  this->mapping_type = {mapping_raviart_thomas};
+  this->mapping_kind = {mapping_raviart_thomas};
   // Initialize support points and quadrature weights
   initialize_support_points(deg);
   // Compute the inverse node matrix to get
index 2a186b650a036aebca0c792a1c5c29debfe9c88c..d809a20c67037d2d68649fd9acac85ac125cc14a 100644 (file)
@@ -670,7 +670,7 @@ template <int dim, int spacedim>
 void
 MappingCartesian<dim, spacedim>::transform(
   const ArrayView<const Tensor<1, dim>> &                  input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<1, spacedim>> &                   output) const
 {
@@ -679,7 +679,7 @@ MappingCartesian<dim, spacedim>::transform(
          ExcInternalError());
   const InternalData &data = static_cast<const InternalData &>(mapping_data);
 
-  switch (mapping_type)
+  switch (mapping_kind)
     {
       case mapping_covariant:
         {
@@ -730,7 +730,7 @@ template <int dim, int spacedim>
 void
 MappingCartesian<dim, spacedim>::transform(
   const ArrayView<const DerivativeForm<1, dim, spacedim>> &input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<2, spacedim>> &                   output) const
 {
@@ -739,7 +739,7 @@ MappingCartesian<dim, spacedim>::transform(
          ExcInternalError());
   const InternalData &data = static_cast<const InternalData &>(mapping_data);
 
-  switch (mapping_type)
+  switch (mapping_kind)
     {
       case mapping_covariant:
         {
@@ -840,7 +840,7 @@ template <int dim, int spacedim>
 void
 MappingCartesian<dim, spacedim>::transform(
   const ArrayView<const Tensor<2, dim>> &                  input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<2, spacedim>> &                   output) const
 {
@@ -849,7 +849,7 @@ MappingCartesian<dim, spacedim>::transform(
          ExcInternalError());
   const InternalData &data = static_cast<const InternalData &>(mapping_data);
 
-  switch (mapping_type)
+  switch (mapping_kind)
     {
       case mapping_covariant:
         {
@@ -949,7 +949,7 @@ template <int dim, int spacedim>
 void
 MappingCartesian<dim, spacedim>::transform(
   const ArrayView<const DerivativeForm<2, dim, spacedim>> &input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<3, spacedim>> &                   output) const
 {
@@ -958,7 +958,7 @@ MappingCartesian<dim, spacedim>::transform(
          ExcInternalError());
   const InternalData &data = static_cast<const InternalData &>(mapping_data);
 
-  switch (mapping_type)
+  switch (mapping_kind)
     {
       case mapping_covariant_gradient:
         {
@@ -986,7 +986,7 @@ template <int dim, int spacedim>
 void
 MappingCartesian<dim, spacedim>::transform(
   const ArrayView<const Tensor<3, dim>> &                  input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<3, spacedim>> &                   output) const
 {
@@ -995,7 +995,7 @@ MappingCartesian<dim, spacedim>::transform(
          ExcInternalError());
   const InternalData &data = static_cast<const InternalData &>(mapping_data);
 
-  switch (mapping_type)
+  switch (mapping_kind)
     {
       case mapping_contravariant_hessian:
         {
index 04dd115174f99bf14355913666932b88386df018..dae76e0614f71569456e3839e069bd96869a0732 100644 (file)
@@ -1965,7 +1965,7 @@ namespace internal
       void
       transform_fields(
         const ArrayView<const Tensor<rank, dim>> &               input,
-        const MappingType                                        mapping_type,
+        const MappingKind                                        mapping_kind,
         const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
         const ArrayView<Tensor<rank, spacedim>> &                output)
       {
@@ -1984,7 +1984,7 @@ namespace internal
               MappingFEField<dim, spacedim, VectorType, DoFHandlerType>::
                 InternalData &>(mapping_data);
 
-        switch (mapping_type)
+        switch (mapping_kind)
           {
             case mapping_contravariant:
               {
@@ -2051,7 +2051,7 @@ namespace internal
       void
       transform_differential_forms(
         const ArrayView<const DerivativeForm<rank, dim, spacedim>> &input,
-        const MappingType                                        mapping_type,
+        const MappingKind                                        mapping_kind,
         const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
         const ArrayView<Tensor<rank + 1, spacedim>> &            output)
       {
@@ -2070,7 +2070,7 @@ namespace internal
               MappingFEField<dim, spacedim, VectorType, DoFHandlerType>::
                 InternalData &>(mapping_data);
 
-        switch (mapping_type)
+        switch (mapping_kind)
           {
             case mapping_covariant:
               {
@@ -2098,7 +2098,7 @@ template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 void
 MappingFEField<dim, spacedim, VectorType, DoFHandlerType>::transform(
   const ArrayView<const Tensor<1, dim>> &                  input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<1, spacedim>> &                   output) const
 {
@@ -2106,7 +2106,7 @@ MappingFEField<dim, spacedim, VectorType, DoFHandlerType>::transform(
 
   internal::MappingFEFieldImplementation::
     transform_fields<dim, spacedim, 1, VectorType, DoFHandlerType>(input,
-                                                                   mapping_type,
+                                                                   mapping_kind,
                                                                    mapping_data,
                                                                    output);
 }
@@ -2117,7 +2117,7 @@ template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 void
 MappingFEField<dim, spacedim, VectorType, DoFHandlerType>::transform(
   const ArrayView<const DerivativeForm<1, dim, spacedim>> &input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<2, spacedim>> &                   output) const
 {
@@ -2125,7 +2125,7 @@ MappingFEField<dim, spacedim, VectorType, DoFHandlerType>::transform(
 
   internal::MappingFEFieldImplementation::
     transform_differential_forms<dim, spacedim, 1, VectorType, DoFHandlerType>(
-      input, mapping_type, mapping_data, output);
+      input, mapping_kind, mapping_data, output);
 }
 
 
@@ -2134,7 +2134,7 @@ template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 void
 MappingFEField<dim, spacedim, VectorType, DoFHandlerType>::transform(
   const ArrayView<const Tensor<2, dim>> &input,
-  const MappingType,
+  const MappingKind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<2, spacedim>> &                   output) const
 {
@@ -2152,7 +2152,7 @@ template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 void
 MappingFEField<dim, spacedim, VectorType, DoFHandlerType>::transform(
   const ArrayView<const DerivativeForm<2, dim, spacedim>> &input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<3, spacedim>> &                   output) const
 {
@@ -2161,7 +2161,7 @@ MappingFEField<dim, spacedim, VectorType, DoFHandlerType>::transform(
          ExcInternalError());
   const InternalData &data = static_cast<const InternalData &>(mapping_data);
 
-  switch (mapping_type)
+  switch (mapping_kind)
     {
       case mapping_covariant_gradient:
         {
@@ -2200,7 +2200,7 @@ template <int dim, int spacedim, typename VectorType, typename DoFHandlerType>
 void
 MappingFEField<dim, spacedim, VectorType, DoFHandlerType>::transform(
   const ArrayView<const Tensor<3, dim>> &input,
-  const MappingType /*mapping_type*/,
+  const MappingKind /*mapping_kind*/,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<3, spacedim>> &                   output) const
 {
index a6b783d73d7b23dde45a62fe1f5daf13d10f918b..392f2b250ed431793c8c1829485c16f17acbf695 100644 (file)
@@ -871,7 +871,7 @@ namespace internal
       void
       transform_fields(
         const ArrayView<const Tensor<rank, dim>> &               input,
-        const MappingType                                        mapping_type,
+        const MappingKind                                        mapping_kind,
         const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
         const ArrayView<Tensor<rank, spacedim>> &                output)
       {
@@ -885,7 +885,7 @@ namespace internal
             static_cast<const typename dealii::MappingManifold<dim, spacedim>::
                           InternalData &>(mapping_data);
 
-        switch (mapping_type)
+        switch (mapping_kind)
           {
             case mapping_contravariant:
               {
@@ -949,7 +949,7 @@ namespace internal
       void
       transform_gradients(
         const ArrayView<const Tensor<rank, dim>> &               input,
-        const MappingType                                        mapping_type,
+        const MappingKind                                        mapping_kind,
         const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
         const ArrayView<Tensor<rank, spacedim>> &                output)
       {
@@ -963,7 +963,7 @@ namespace internal
             static_cast<const typename dealii::MappingManifold<dim, spacedim>::
                           InternalData &>(mapping_data);
 
-        switch (mapping_type)
+        switch (mapping_kind)
           {
             case mapping_contravariant_gradient:
               {
@@ -1051,7 +1051,7 @@ namespace internal
       void
       transform_hessians(
         const ArrayView<const Tensor<3, dim>> &                  input,
-        const MappingType                                        mapping_type,
+        const MappingKind                                        mapping_kind,
         const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
         const ArrayView<Tensor<3, spacedim>> &                   output)
       {
@@ -1065,7 +1065,7 @@ namespace internal
             static_cast<const typename dealii::MappingManifold<dim, spacedim>::
                           InternalData &>(mapping_data);
 
-        switch (mapping_type)
+        switch (mapping_kind)
           {
             case mapping_contravariant_hessian:
               {
@@ -1220,7 +1220,7 @@ namespace internal
       void
       transform_differential_forms(
         const ArrayView<const DerivativeForm<rank, dim, spacedim>> &input,
-        const MappingType                                        mapping_type,
+        const MappingKind                                        mapping_kind,
         const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
         const ArrayView<Tensor<rank + 1, spacedim>> &            output)
       {
@@ -1234,7 +1234,7 @@ namespace internal
             static_cast<const typename dealii::MappingManifold<dim, spacedim>::
                           InternalData &>(mapping_data);
 
-        switch (mapping_type)
+        switch (mapping_kind)
           {
             case mapping_covariant:
               {
@@ -1329,12 +1329,12 @@ template <int dim, int spacedim>
 void
 MappingManifold<dim, spacedim>::transform(
   const ArrayView<const Tensor<1, dim>> &                  input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<1, spacedim>> &                   output) const
 {
   internal::MappingManifoldImplementation::transform_fields(input,
-                                                            mapping_type,
+                                                            mapping_kind,
                                                             mapping_data,
                                                             output);
 }
@@ -1345,12 +1345,12 @@ template <int dim, int spacedim>
 void
 MappingManifold<dim, spacedim>::transform(
   const ArrayView<const DerivativeForm<1, dim, spacedim>> &input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<2, spacedim>> &                   output) const
 {
   internal::MappingManifoldImplementation::transform_differential_forms(
-    input, mapping_type, mapping_data, output);
+    input, mapping_kind, mapping_data, output);
 }
 
 
@@ -1359,15 +1359,15 @@ template <int dim, int spacedim>
 void
 MappingManifold<dim, spacedim>::transform(
   const ArrayView<const Tensor<2, dim>> &                  input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<2, spacedim>> &                   output) const
 {
-  switch (mapping_type)
+  switch (mapping_kind)
     {
       case mapping_contravariant:
         internal::MappingManifoldImplementation::transform_fields(input,
-                                                                  mapping_type,
+                                                                  mapping_kind,
                                                                   mapping_data,
                                                                   output);
         return;
@@ -1376,7 +1376,7 @@ MappingManifold<dim, spacedim>::transform(
       case mapping_contravariant_gradient:
       case mapping_covariant_gradient:
         internal::MappingManifoldImplementation::transform_gradients(
-          input, mapping_type, mapping_data, output);
+          input, mapping_kind, mapping_data, output);
         return;
       default:
         Assert(false, ExcNotImplemented());
@@ -1389,7 +1389,7 @@ template <int dim, int spacedim>
 void
 MappingManifold<dim, spacedim>::transform(
   const ArrayView<const DerivativeForm<2, dim, spacedim>> &input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<3, spacedim>> &                   output) const
 {
@@ -1398,7 +1398,7 @@ MappingManifold<dim, spacedim>::transform(
          ExcInternalError());
   const InternalData &data = static_cast<const InternalData &>(mapping_data);
 
-  switch (mapping_type)
+  switch (mapping_kind)
     {
       case mapping_covariant_gradient:
         {
@@ -1438,17 +1438,17 @@ template <int dim, int spacedim>
 void
 MappingManifold<dim, spacedim>::transform(
   const ArrayView<const Tensor<3, dim>> &                  input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<3, spacedim>> &                   output) const
 {
-  switch (mapping_type)
+  switch (mapping_kind)
     {
       case mapping_piola_hessian:
       case mapping_contravariant_hessian:
       case mapping_covariant_hessian:
         internal::MappingManifoldImplementation::transform_hessians(
-          input, mapping_type, mapping_data, output);
+          input, mapping_kind, mapping_data, output);
         return;
       default:
         Assert(false, ExcNotImplemented());
index 6cf47d04ed2e33e779a52e7d66e95778685ae89c..1cc552679a775241a79fbfd8a2f03d3da9988094 100644 (file)
@@ -384,7 +384,7 @@ template <int dim, int spacedim>
 void
 MappingQ<dim, spacedim>::transform(
   const ArrayView<const Tensor<1, dim>> &                  input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<1, spacedim>> &                   output) const
 {
@@ -395,10 +395,10 @@ MappingQ<dim, spacedim>::transform(
 
   // check whether we should in fact work on the Q1 portion of it
   if (data->use_mapping_q1_on_current_cell)
-    q1_mapping->transform(input, mapping_type, *data->mapping_q1_data, output);
+    q1_mapping->transform(input, mapping_kind, *data->mapping_q1_data, output);
   else
     // otherwise use the full mapping
-    qp_mapping->transform(input, mapping_type, *data->mapping_qp_data, output);
+    qp_mapping->transform(input, mapping_kind, *data->mapping_qp_data, output);
 }
 
 
@@ -407,7 +407,7 @@ template <int dim, int spacedim>
 void
 MappingQ<dim, spacedim>::transform(
   const ArrayView<const DerivativeForm<1, dim, spacedim>> &input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<2, spacedim>> &                   output) const
 {
@@ -419,10 +419,10 @@ MappingQ<dim, spacedim>::transform(
 
   // check whether we should in fact work on the Q1 portion of it
   if (data->use_mapping_q1_on_current_cell)
-    q1_mapping->transform(input, mapping_type, *data->mapping_q1_data, output);
+    q1_mapping->transform(input, mapping_kind, *data->mapping_q1_data, output);
   else
     // otherwise use the full mapping
-    qp_mapping->transform(input, mapping_type, *data->mapping_qp_data, output);
+    qp_mapping->transform(input, mapping_kind, *data->mapping_qp_data, output);
 }
 
 
@@ -431,7 +431,7 @@ template <int dim, int spacedim>
 void
 MappingQ<dim, spacedim>::transform(
   const ArrayView<const Tensor<2, dim>> &                  input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<2, spacedim>> &                   output) const
 {
@@ -443,10 +443,10 @@ MappingQ<dim, spacedim>::transform(
 
   // check whether we should in fact work on the Q1 portion of it
   if (data->use_mapping_q1_on_current_cell)
-    q1_mapping->transform(input, mapping_type, *data->mapping_q1_data, output);
+    q1_mapping->transform(input, mapping_kind, *data->mapping_q1_data, output);
   else
     // otherwise use the full mapping
-    qp_mapping->transform(input, mapping_type, *data->mapping_qp_data, output);
+    qp_mapping->transform(input, mapping_kind, *data->mapping_qp_data, output);
 }
 
 
@@ -455,7 +455,7 @@ template <int dim, int spacedim>
 void
 MappingQ<dim, spacedim>::transform(
   const ArrayView<const DerivativeForm<2, dim, spacedim>> &input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<3, spacedim>> &                   output) const
 {
@@ -467,10 +467,10 @@ MappingQ<dim, spacedim>::transform(
 
   // check whether we should in fact work on the Q1 portion of it
   if (data->use_mapping_q1_on_current_cell)
-    q1_mapping->transform(input, mapping_type, *data->mapping_q1_data, output);
+    q1_mapping->transform(input, mapping_kind, *data->mapping_q1_data, output);
   else
     // otherwise use the full mapping
-    qp_mapping->transform(input, mapping_type, *data->mapping_qp_data, output);
+    qp_mapping->transform(input, mapping_kind, *data->mapping_qp_data, output);
 }
 
 
@@ -479,7 +479,7 @@ template <int dim, int spacedim>
 void
 MappingQ<dim, spacedim>::transform(
   const ArrayView<const Tensor<3, dim>> &                  input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<3, spacedim>> &                   output) const
 {
@@ -491,10 +491,10 @@ MappingQ<dim, spacedim>::transform(
 
   // check whether we should in fact work on the Q1 portion of it
   if (data->use_mapping_q1_on_current_cell)
-    q1_mapping->transform(input, mapping_type, *data->mapping_q1_data, output);
+    q1_mapping->transform(input, mapping_kind, *data->mapping_q1_data, output);
   else
     // otherwise use the full mapping
-    qp_mapping->transform(input, mapping_type, *data->mapping_qp_data, output);
+    qp_mapping->transform(input, mapping_kind, *data->mapping_qp_data, output);
 }
 
 
index 1bb970820a04b4391554ddd15dab3cc585546bc2..8f0095575023fe7db7345c082c3acdcbf8a3ea2d 100644 (file)
@@ -3354,7 +3354,7 @@ namespace internal
       void
       transform_fields(
         const ArrayView<const Tensor<rank, dim>> &               input,
-        const MappingType                                        mapping_type,
+        const MappingKind                                        mapping_kind,
         const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
         const ArrayView<Tensor<rank, spacedim>> &                output)
       {
@@ -3368,7 +3368,7 @@ namespace internal
             static_cast<const typename dealii::MappingQGeneric<dim, spacedim>::
                           InternalData &>(mapping_data);
 
-        switch (mapping_type)
+        switch (mapping_kind)
           {
             case mapping_contravariant:
               {
@@ -3432,7 +3432,7 @@ namespace internal
       void
       transform_gradients(
         const ArrayView<const Tensor<rank, dim>> &               input,
-        const MappingType                                        mapping_type,
+        const MappingKind                                        mapping_kind,
         const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
         const ArrayView<Tensor<rank, spacedim>> &                output)
       {
@@ -3446,7 +3446,7 @@ namespace internal
             static_cast<const typename dealii::MappingQGeneric<dim, spacedim>::
                           InternalData &>(mapping_data);
 
-        switch (mapping_type)
+        switch (mapping_kind)
           {
             case mapping_contravariant_gradient:
               {
@@ -3534,7 +3534,7 @@ namespace internal
       void
       transform_hessians(
         const ArrayView<const Tensor<3, dim>> &                  input,
-        const MappingType                                        mapping_type,
+        const MappingKind                                        mapping_kind,
         const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
         const ArrayView<Tensor<3, spacedim>> &                   output)
       {
@@ -3548,7 +3548,7 @@ namespace internal
             static_cast<const typename dealii::MappingQGeneric<dim, spacedim>::
                           InternalData &>(mapping_data);
 
-        switch (mapping_type)
+        switch (mapping_kind)
           {
             case mapping_contravariant_hessian:
               {
@@ -3703,7 +3703,7 @@ namespace internal
       void
       transform_differential_forms(
         const ArrayView<const DerivativeForm<rank, dim, spacedim>> &input,
-        const MappingType                                        mapping_type,
+        const MappingKind                                        mapping_kind,
         const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
         const ArrayView<Tensor<rank + 1, spacedim>> &            output)
       {
@@ -3717,7 +3717,7 @@ namespace internal
             static_cast<const typename dealii::MappingQGeneric<dim, spacedim>::
                           InternalData &>(mapping_data);
 
-        switch (mapping_type)
+        switch (mapping_kind)
           {
             case mapping_covariant:
               {
@@ -3745,12 +3745,12 @@ template <int dim, int spacedim>
 void
 MappingQGeneric<dim, spacedim>::transform(
   const ArrayView<const Tensor<1, dim>> &                  input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<1, spacedim>> &                   output) const
 {
   internal::MappingQGenericImplementation::transform_fields(input,
-                                                            mapping_type,
+                                                            mapping_kind,
                                                             mapping_data,
                                                             output);
 }
@@ -3761,12 +3761,12 @@ template <int dim, int spacedim>
 void
 MappingQGeneric<dim, spacedim>::transform(
   const ArrayView<const DerivativeForm<1, dim, spacedim>> &input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<2, spacedim>> &                   output) const
 {
   internal::MappingQGenericImplementation::transform_differential_forms(
-    input, mapping_type, mapping_data, output);
+    input, mapping_kind, mapping_data, output);
 }
 
 
@@ -3775,15 +3775,15 @@ template <int dim, int spacedim>
 void
 MappingQGeneric<dim, spacedim>::transform(
   const ArrayView<const Tensor<2, dim>> &                  input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<2, spacedim>> &                   output) const
 {
-  switch (mapping_type)
+  switch (mapping_kind)
     {
       case mapping_contravariant:
         internal::MappingQGenericImplementation::transform_fields(input,
-                                                                  mapping_type,
+                                                                  mapping_kind,
                                                                   mapping_data,
                                                                   output);
         return;
@@ -3792,7 +3792,7 @@ MappingQGeneric<dim, spacedim>::transform(
       case mapping_contravariant_gradient:
       case mapping_covariant_gradient:
         internal::MappingQGenericImplementation::transform_gradients(
-          input, mapping_type, mapping_data, output);
+          input, mapping_kind, mapping_data, output);
         return;
       default:
         Assert(false, ExcNotImplemented());
@@ -3805,7 +3805,7 @@ template <int dim, int spacedim>
 void
 MappingQGeneric<dim, spacedim>::transform(
   const ArrayView<const DerivativeForm<2, dim, spacedim>> &input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<3, spacedim>> &                   output) const
 {
@@ -3814,7 +3814,7 @@ MappingQGeneric<dim, spacedim>::transform(
          ExcInternalError());
   const InternalData &data = static_cast<const InternalData &>(mapping_data);
 
-  switch (mapping_type)
+  switch (mapping_kind)
     {
       case mapping_covariant_gradient:
         {
@@ -3854,17 +3854,17 @@ template <int dim, int spacedim>
 void
 MappingQGeneric<dim, spacedim>::transform(
   const ArrayView<const Tensor<3, dim>> &                  input,
-  const MappingType                                        mapping_type,
+  const MappingKind                                        mapping_kind,
   const typename Mapping<dim, spacedim>::InternalDataBase &mapping_data,
   const ArrayView<Tensor<3, spacedim>> &                   output) const
 {
-  switch (mapping_type)
+  switch (mapping_kind)
     {
       case mapping_piola_hessian:
       case mapping_contravariant_hessian:
       case mapping_covariant_hessian:
         internal::MappingQGenericImplementation::transform_hessians(
-          input, mapping_type, mapping_data, output);
+          input, mapping_kind, mapping_data, output);
         return;
       default:
         Assert(false, ExcNotImplemented());

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.