]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Minor clean-ups.
authorWolfgang Bangerth <bangerth@colostate.edu>
Thu, 25 Jul 2019 15:13:36 +0000 (09:13 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Thu, 25 Jul 2019 15:13:36 +0000 (09:13 -0600)
include/deal.II/fe/fe_poly_tensor.h
source/fe/fe_poly_tensor.cc

index 4bb34d4dc8a2f340b532000f3bc1e4e6361b03d0..74718870d4163b6ac920575fe6af602851231da8 100644 (file)
@@ -221,13 +221,13 @@ protected:
    * mapping and false when the finite element uses multiple mappings.
    */
   bool
-  single_mapping() const;
+  single_mapping_type() const;
 
   /**
    * Returns MappingType @p i for the finite element.
    */
   MappingType
-  get_mapping_type(unsigned int i) const;
+  get_mapping_type(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
index 28bc8e5a52d60460757c1622049e4bedd8e81825..6e2f842c544373f1c85f43e1e1de02137ec6e2de 100644 (file)
@@ -196,7 +196,7 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::FE_PolyTensor(
 
 template <class PolynomialType, int dim, int spacedim>
 bool
-FE_PolyTensor<PolynomialType, dim, spacedim>::single_mapping() const
+FE_PolyTensor<PolynomialType, dim, spacedim>::single_mapping_type() const
 {
   return mapping_type.size() == 1;
 }
@@ -206,10 +206,11 @@ FE_PolyTensor<PolynomialType, dim, spacedim>::single_mapping() const
 template <class PolynomialType, int dim, int spacedim>
 MappingType
 FE_PolyTensor<PolynomialType, dim, spacedim>::get_mapping_type(
-  unsigned int i) const
+  const unsigned int i) const
 {
-  if (single_mapping())
+  if (single_mapping_type())
     return mapping_type[0];
+
   Assert(i < mapping_type.size(), ExcIndexRange(i, 0, mapping_type.size()));
   return mapping_type[i];
 }

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.