]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Mark some constructors as explicit
authorDaniel Arndt <arndtd@ornl.gov>
Tue, 20 Jun 2023 21:19:27 +0000 (17:19 -0400)
committerDaniel Arndt <arndtd@ornl.gov>
Mon, 3 Jul 2023 20:55:57 +0000 (16:55 -0400)
29 files changed:
include/deal.II/base/conditional_ostream.h
include/deal.II/base/table_handler.h
include/deal.II/fe/block_mask.h
include/deal.II/fe/component_mask.h
include/deal.II/lac/slepc_solver.h
include/deal.II/lac/slepc_spectral_transformation.h
include/deal.II/lac/solver_control.h
source/dofs/dof_tools.cc
source/fe/fe.cc
source/fe/fe_abf.cc
source/fe/fe_bdm.cc
source/fe/fe_bernardi_raugel.cc
source/fe/fe_dgp.cc
source/fe/fe_dgp_monomial.cc
source/fe/fe_dgp_nonparametric.cc
source/fe/fe_dgq.cc
source/fe/fe_nedelec.cc
source/fe/fe_nedelec_sz.cc
source/fe/fe_pyramid_p.cc
source/fe/fe_q_base.cc
source/fe/fe_q_hierarchical.cc
source/fe/fe_rannacher_turek.cc
source/fe/fe_raviart_thomas.cc
source/fe/fe_raviart_thomas_nodal.cc
source/fe/fe_rt_bubbles.cc
source/fe/fe_simplex_p.cc
source/fe/fe_wedge_p.cc
source/multigrid/mg_tools.cc
source/numerics/point_value_history.cc

index c05c2c67b1f859e303a62a8944b17247bd7e9fa0..d3827e17ea6e59f1167792689e035e1657b9b9ae 100644 (file)
@@ -85,7 +85,7 @@ public:
    * based on which writes are actually forwarded. Per default the condition
    * of an object is active.
    */
-  ConditionalOStream(std::ostream &stream, const bool active = true);
+  explicit ConditionalOStream(std::ostream &stream, const bool active = true);
 
   /**
    * Depending on the <tt>active</tt> flag set the condition of this stream to
index a55bc25941ae16e029bb204d48f57fd39d37c55d..a3e60825a807675a395d66e37824cce5cf9756ca 100644 (file)
@@ -64,7 +64,7 @@ namespace internal
      * <code>t</code>.
      */
     template <typename T>
-    TableEntry(const T &t);
+    explicit TableEntry(const T &t);
 
     /**
      * Return the value stored by this object. The template type T must be one
@@ -634,7 +634,7 @@ protected:
     /**
      * Constructor.
      */
-    Column(const std::string &tex_caption);
+    explicit Column(const std::string &tex_caption);
 
     /**
      * Pad this column with default constructed elements to the number of rows
index c27db0e84616bad9101ad868a558052777f8f66a..ca6fa0e898ca66f6651f2bc264b149e771d68e11 100644 (file)
@@ -89,7 +89,7 @@ public:
    * the given vector is zero, then this interpreted as the case where
    * <i>every</i> block is selected.
    */
-  BlockMask(const std::vector<bool> &block_mask);
+  explicit BlockMask(const std::vector<bool> &block_mask);
 
   /**
    * Initialize the block mask with a number of elements that are either all
@@ -345,7 +345,7 @@ BlockMask::operator|(const BlockMask &mask) const
       for (unsigned int i = 0; i < block_mask.size(); ++i)
         new_mask[i] = (block_mask[i] || mask.block_mask[i]);
 
-      return new_mask;
+      return BlockMask(new_mask);
     }
 }
 
@@ -368,7 +368,7 @@ BlockMask::operator&(const BlockMask &mask) const
       for (unsigned int i = 0; i < block_mask.size(); ++i)
         new_mask[i] = (block_mask[i] && mask.block_mask[i]);
 
-      return new_mask;
+      return BlockMask(new_mask);
     }
 }
 
index d2d03218f808347b29d5f72104e4685354447364..37209e7225685011439f04e345331327b3388bc9 100644 (file)
@@ -98,7 +98,7 @@ public:
    * length of the given vector is zero, then this interpreted as the case
    * where <i>every</i> component is selected.
    */
-  ComponentMask(const std::vector<bool> &component_mask);
+  explicit ComponentMask(const std::vector<bool> &component_mask);
 
   /**
    * Initialize the component mask with a number of elements that are either
@@ -375,7 +375,7 @@ ComponentMask::operator|(const ComponentMask &mask) const
       for (unsigned int i = 0; i < component_mask.size(); ++i)
         new_mask[i] = (component_mask[i] || mask.component_mask[i]);
 
-      return new_mask;
+      return ComponentMask(new_mask);
     }
 }
 
@@ -398,7 +398,7 @@ ComponentMask::operator&(const ComponentMask &mask) const
       for (unsigned int i = 0; i < component_mask.size(); ++i)
         new_mask[i] = (component_mask[i] && mask.component_mask[i]);
 
-      return new_mask;
+      return ComponentMask(new_mask);
     }
 }
 
index 1bbfe87a7fc80dd580778f89d15bf86cec2c2ef0..56c893749bc43fbd0e17b321e25393891eda5e9a 100644 (file)
@@ -404,9 +404,10 @@ namespace SLEPcWrappers
      * computations are parallelized. By default, this carries the same
      * behavior as the PETScWrappers, but you can change that.
      */
-    SolverKrylovSchur(SolverControl &       cn,
-                      const MPI_Comm        mpi_communicator = PETSC_COMM_SELF,
-                      const AdditionalData &data = AdditionalData());
+    explicit SolverKrylovSchur(
+      SolverControl &       cn,
+      const MPI_Comm        mpi_communicator = PETSC_COMM_SELF,
+      const AdditionalData &data             = AdditionalData());
 
   protected:
     /**
@@ -442,7 +443,7 @@ namespace SLEPcWrappers
        * Constructor. By default, set the option of delayed
        * reorthogonalization to false, i.e. don't do it.
        */
-      AdditionalData(const bool delayed_reorthogonalization = false);
+      explicit AdditionalData(const bool delayed_reorthogonalization = false);
 
       /**
        * Flag for delayed reorthogonalization.
@@ -455,9 +456,9 @@ namespace SLEPcWrappers
      * computations are parallelized. By default, this carries the same
      * behavior as the PETScWrappers, but you can change that.
      */
-    SolverArnoldi(SolverControl &       cn,
-                  const MPI_Comm        mpi_communicator = PETSC_COMM_SELF,
-                  const AdditionalData &data             = AdditionalData());
+    explicit SolverArnoldi(SolverControl &cn,
+                           const MPI_Comm mpi_communicator = PETSC_COMM_SELF,
+                           const AdditionalData &data      = AdditionalData());
 
   protected:
     /**
@@ -498,7 +499,7 @@ namespace SLEPcWrappers
        * Constructor. By default sets the type of reorthogonalization used
        * during the Lanczos iteration to full.
        */
-      AdditionalData(
+      explicit AdditionalData(
         const EPSLanczosReorthogType r = EPS_LANCZOS_REORTHOG_FULL);
     };
 
@@ -507,9 +508,9 @@ namespace SLEPcWrappers
      * computations are parallelized. By default, this carries the same
      * behavior as the PETScWrappers, but you can change that.
      */
-    SolverLanczos(SolverControl &       cn,
-                  const MPI_Comm        mpi_communicator = PETSC_COMM_SELF,
-                  const AdditionalData &data             = AdditionalData());
+    explicit SolverLanczos(SolverControl &cn,
+                           const MPI_Comm mpi_communicator = PETSC_COMM_SELF,
+                           const AdditionalData &data      = AdditionalData());
 
   protected:
     /**
@@ -547,9 +548,9 @@ namespace SLEPcWrappers
      * computations are parallelized. By default, this carries the same
      * behavior as the PETScWrappers, but you can change that.
      */
-    SolverPower(SolverControl &       cn,
-                const MPI_Comm        mpi_communicator = PETSC_COMM_SELF,
-                const AdditionalData &data             = AdditionalData());
+    explicit SolverPower(SolverControl &cn,
+                         const MPI_Comm mpi_communicator = PETSC_COMM_SELF,
+                         const AdditionalData &data      = AdditionalData());
 
   protected:
     /**
@@ -589,7 +590,7 @@ namespace SLEPcWrappers
       /**
        * Constructor. By default set double_expansion to false.
        */
-      AdditionalData(bool double_expansion = false);
+      explicit AdditionalData(bool double_expansion = false);
     };
 
     /**
@@ -597,9 +598,10 @@ namespace SLEPcWrappers
      * computations are parallelized. By default, this carries the same
      * behavior as the PETScWrappers, but you can change that.
      */
-    SolverGeneralizedDavidson(SolverControl &cn,
-                              const MPI_Comm mpi_communicator = PETSC_COMM_SELF,
-                              const AdditionalData &data = AdditionalData());
+    explicit SolverGeneralizedDavidson(
+      SolverControl &       cn,
+      const MPI_Comm        mpi_communicator = PETSC_COMM_SELF,
+      const AdditionalData &data             = AdditionalData());
 
   protected:
     /**
@@ -637,9 +639,10 @@ namespace SLEPcWrappers
      * computations are parallelized. By default, this carries the same
      * behavior as the PETScWrappers, but you can change that.
      */
-    SolverJacobiDavidson(SolverControl &cn,
-                         const MPI_Comm mpi_communicator = PETSC_COMM_SELF,
-                         const AdditionalData &data      = AdditionalData());
+    explicit SolverJacobiDavidson(
+      SolverControl &       cn,
+      const MPI_Comm        mpi_communicator = PETSC_COMM_SELF,
+      const AdditionalData &data             = AdditionalData());
 
   protected:
     /**
@@ -677,9 +680,9 @@ namespace SLEPcWrappers
      * computations are parallelized. By default, this carries the same
      * behavior as the PETScWrappers, but you can change that.
      */
-    SolverLAPACK(SolverControl &       cn,
-                 const MPI_Comm        mpi_communicator = PETSC_COMM_SELF,
-                 const AdditionalData &data             = AdditionalData());
+    explicit SolverLAPACK(SolverControl &cn,
+                          const MPI_Comm mpi_communicator = PETSC_COMM_SELF,
+                          const AdditionalData &data      = AdditionalData());
 
   protected:
     /**
index 73c5cbe25c6ce84441ceaa48aaee89804be2225b..378571d3d28f812b00dba53faa09106555acee69 100644 (file)
@@ -79,7 +79,7 @@ namespace SLEPcWrappers
     /**
      * Constructor.
      */
-    TransformationBase(const MPI_Comm mpi_communicator);
+    explicit TransformationBase(const MPI_Comm mpi_communicator);
 
   public:
     /**
@@ -132,7 +132,7 @@ namespace SLEPcWrappers
       /**
        * Constructor. By default, set the shift parameter to zero.
        */
-      AdditionalData(const double shift_parameter = 0);
+      explicit AdditionalData(const double shift_parameter = 0);
 
       /**
        * Shift parameter.
@@ -144,8 +144,8 @@ namespace SLEPcWrappers
     /**
      * Constructor.
      */
-    TransformationShift(const MPI_Comm        mpi_communicator,
-                        const AdditionalData &data = AdditionalData());
+    explicit TransformationShift(const MPI_Comm        mpi_communicator,
+                                 const AdditionalData &data = AdditionalData());
 
 
   protected:
@@ -172,7 +172,7 @@ namespace SLEPcWrappers
       /**
        * Constructor. By default, set the shift parameter to zero.
        */
-      AdditionalData(const double shift_parameter = 0);
+      explicit AdditionalData(const double shift_parameter = 0);
 
       /**
        * Shift parameter.
@@ -184,8 +184,9 @@ namespace SLEPcWrappers
     /**
      * Constructor.
      */
-    TransformationShiftInvert(const MPI_Comm        mpi_communicator,
-                              const AdditionalData &data = AdditionalData());
+    explicit TransformationShiftInvert(
+      const MPI_Comm        mpi_communicator,
+      const AdditionalData &data = AdditionalData());
 
   protected:
     /**
@@ -220,7 +221,7 @@ namespace SLEPcWrappers
       /**
        * Constructor. By default, set the shift parameter to zero.
        */
-      AdditionalData(const double shift_parameter = 0);
+      explicit AdditionalData(const double shift_parameter = 0);
 
       /**
        * Shift parameter.
@@ -232,7 +233,7 @@ namespace SLEPcWrappers
     /**
      * Constructor.
      */
-    TransformationSpectrumFolding(
+    explicit TransformationSpectrumFolding(
       const MPI_Comm        mpi_communicator,
       const AdditionalData &data = AdditionalData());
 
@@ -259,8 +260,8 @@ namespace SLEPcWrappers
       /**
        * Constructor. Requires two shift parameters
        */
-      AdditionalData(const double shift_parameter     = 0,
-                     const double antishift_parameter = 0);
+      explicit AdditionalData(const double shift_parameter     = 0,
+                              const double antishift_parameter = 0);
 
       /**
        * Shift parameter.
@@ -277,8 +278,9 @@ namespace SLEPcWrappers
     /**
      * Constructor.
      */
-    TransformationCayley(const MPI_Comm        mpi_communicator,
-                         const AdditionalData &data = AdditionalData());
+    explicit TransformationCayley(
+      const MPI_Comm        mpi_communicator,
+      const AdditionalData &data = AdditionalData());
 
   protected:
     /**
index 45508e12d5fcba85063b6f2edca4516cee220a59..c7e263507fb1d2feda5fee45aa3200ced9df0e71 100644 (file)
@@ -439,7 +439,7 @@ public:
    * Initialize with a SolverControl object. The result will emulate
    * SolverControl by setting @p reduce to zero.
    */
-  ReductionControl(const SolverControl &c);
+  explicit ReductionControl(const SolverControl &c);
 
   /**
    * Assign a SolverControl object to ReductionControl. The result of the
@@ -525,7 +525,7 @@ public:
    * Initialize with a SolverControl object. The result will emulate
    * SolverControl by setting the reduction target to zero.
    */
-  IterationNumberControl(const SolverControl &c);
+  explicit IterationNumberControl(const SolverControl &c);
 
   /**
    * Assign a SolverControl object to ReductionControl. The result of the
@@ -581,7 +581,7 @@ public:
    * Initialize with a SolverControl object. The result will emulate
    * SolverControl by setting @p n_consecutive_iterations to one.
    */
-  ConsecutiveControl(const SolverControl &c);
+  explicit ConsecutiveControl(const SolverControl &c);
 
   /**
    * Assign a SolverControl object to ConsecutiveControl. The result of the
index bd2f44dae1b286776a423d7147a62c4d2048199d..3b0d1869943114570106b905f6930ac88b3d68b0 100644 (file)
@@ -1724,7 +1724,7 @@ namespace DoFTools
 
     std::vector<unsigned char> component_association(dof_handler.n_dofs());
     internal::get_component_association(dof_handler,
-                                        std::vector<bool>(),
+                                        ComponentMask(std::vector<bool>()),
                                         component_association);
 
     for (unsigned int c = 0; c < dof_handler.get_fe(0).n_components(); ++c)
index 06c10664de93c5e8617f8e137e7b61e81a962e68..7aa5c5965ad3506401b5907b98f8f91977dd9fe3 100644 (file)
@@ -401,7 +401,7 @@ FiniteElement<dim, spacedim>::component_mask(
 
   std::vector<bool> mask(this->n_components(), false);
   mask[scalar.component] = true;
-  return mask;
+  return ComponentMask(mask);
 }
 
 
@@ -423,7 +423,7 @@ FiniteElement<dim, spacedim>::component_mask(
        c < vector.first_vector_component + dim;
        ++c)
     mask[c] = true;
-  return mask;
+  return ComponentMask(mask);
 }
 
 
@@ -447,7 +447,7 @@ FiniteElement<dim, spacedim>::component_mask(
              SymmetricTensor<2, dim>::n_independent_components;
        ++c)
     mask[c] = true;
-  return mask;
+  return ComponentMask(mask);
 }
 
 
@@ -468,7 +468,7 @@ FiniteElement<dim, spacedim>::component_mask(const BlockMask &block_mask) const
     if (block_mask[component_to_block_index(c)] == true)
       component_mask[c] = true;
 
-  return component_mask;
+  return ComponentMask(component_mask);
 }
 
 
@@ -554,7 +554,7 @@ FiniteElement<dim, spacedim>::block_mask(
     }
 
 
-  return block_mask;
+  return BlockMask(block_mask);
 }
 
 
index d367dd87b6eff99d1ab64297411cedc0e5abef7a..086df3c49e8e6ce93d0d38de014fd954f9df45ff 100644 (file)
@@ -51,7 +51,7 @@ FE_ABF<dim>::FE_ABF(const unsigned int deg)
                              FiniteElementData<dim>::Hdiv),
       std::vector<bool>(PolynomialsABF<dim>::n_polynomials(deg), true),
       std::vector<ComponentMask>(PolynomialsABF<dim>::n_polynomials(deg),
-                                 std::vector<bool>(dim, true)))
+                                 ComponentMask(std::vector<bool>(dim, true))))
   , rt_order(deg)
 {
   Assert(dim >= 2, ExcImpossibleInDim(dim));
index d86b0c953b4c82708919060a863dcd1a1eec4d5a..0d960f5c81c6a0dcc5920cffec5f0a091461962c 100644 (file)
@@ -50,7 +50,7 @@ FE_BDM<dim>::FE_BDM(const unsigned int deg)
                              FiniteElementData<dim>::Hdiv),
       get_ria_vector(deg),
       std::vector<ComponentMask>(PolynomialsBDM<dim>::n_polynomials(deg),
-                                 std::vector<bool>(dim, true)))
+                                 ComponentMask(std::vector<bool>(dim, true))))
 {
   Assert(dim >= 2, ExcImpossibleInDim(dim));
   Assert(
index 393ffd176af0c975b55ff7b64efcf341bee7e6d5..c07a321a43013b40a845c8545250ebcc6e671b1d 100644 (file)
@@ -51,7 +51,7 @@ FE_BernardiRaugel<dim>::FE_BernardiRaugel(const unsigned int p)
       std::vector<bool>(PolynomialsBernardiRaugel<dim>::n_polynomials(p), true),
       std::vector<ComponentMask>(PolynomialsBernardiRaugel<dim>::n_polynomials(
                                    p),
-                                 std::vector<bool>(dim, true)))
+                                 ComponentMask(std::vector<bool>(dim, true))))
 {
   Assert(dim == 2 || dim == 3, ExcImpossibleInDim(dim));
   Assert(p == 1, ExcMessage("Only BR1 elements are available"));
index 724bd4a4019e63fb0ed485f1c21e6e24fb5a4a4a..dad2d33c3198c2c6ced3db2a99105fe99b5ce8b1 100644 (file)
@@ -40,7 +40,7 @@ FE_DGP<dim, spacedim>::FE_DGP(const unsigned int degree)
       std::vector<ComponentMask>(
         FiniteElementData<dim>(get_dpo_vector(degree), 1, degree)
           .n_dofs_per_cell(),
-        std::vector<bool>(1, true)))
+        ComponentMask(std::vector<bool>(1, true))))
 {
   // Reinit the vectors of restriction and prolongation matrices to the right
   // sizes
index b632ee53413a5429b7261c4542377b1ef5884b34..44b2a62e1769a223e61134ecb2d853bf62c2f96f 100644 (file)
@@ -142,7 +142,7 @@ FE_DGPMonomial<dim>::FE_DGPMonomial(const unsigned int degree)
                  std::vector<ComponentMask>(
                    FiniteElementData<dim>(get_dpo_vector(degree), 1, degree)
                      .n_dofs_per_cell(),
-                   std::vector<bool>(1, true)))
+                   ComponentMask(std::vector<bool>(1, true))))
 {
   Assert(this->poly_space->n() == this->n_dofs_per_cell(), ExcInternalError());
   Assert(this->poly_space->degree() == this->degree, ExcInternalError());
index bf5e7db2e1c6536f7d17f09eb4e8d6523682534a..66d1f2d77c720ac496c0b5fef7fd7b2230552464 100644 (file)
@@ -48,7 +48,7 @@ FE_DGPNonparametric<dim, spacedim>::FE_DGPNonparametric(
       std::vector<ComponentMask>(
         FiniteElementData<dim>(get_dpo_vector(degree), 1, degree)
           .n_dofs_per_cell(),
-        std::vector<bool>(1, true)))
+        ComponentMask(std::vector<bool>(1, true))))
   , polynomial_space(Polynomials::Legendre::generate_complete_basis(degree))
 {
   const unsigned int n_dofs = this->n_dofs_per_cell();
index 9ec53290f788fda8e21ba7e7fb6e1cc45b32a587..ff25d2e10a18195ae145451f92c07745ff9ea999 100644 (file)
@@ -79,7 +79,7 @@ FE_DGQ<dim, spacedim>::FE_DGQ(const unsigned int degree)
       std::vector<ComponentMask>(
         FiniteElementData<dim>(get_dpo_vector(degree), 1, degree)
           .n_dofs_per_cell(),
-        std::vector<bool>(1, true)))
+        ComponentMask(std::vector<bool>(1, true))))
 {
   // Compute support points, which are the tensor product of the Lagrange
   // interpolation points in the constructor.
@@ -116,7 +116,7 @@ FE_DGQ<dim, spacedim>::FE_DGQ(
                                1,
                                polynomials.size() - 1)
           .n_dofs_per_cell(),
-        std::vector<bool>(1, true)))
+        ComponentMask(std::vector<bool>(1, true))))
 {
   // No support points can be defined in general. Derived classes might define
   // support points like the class FE_DGQArbitraryNodes
index 4a2bb5757c149eb6995aa368b807de5dd5a4df51..8a7a98527409b319b302152e4241e5ad341b0ff6 100644 (file)
@@ -76,7 +76,7 @@ FE_Nedelec<dim>::FE_Nedelec(const unsigned int order)
                              FiniteElementData<dim>::Hcurl),
       std::vector<bool>(PolynomialsNedelec<dim>::n_polynomials(order), true),
       std::vector<ComponentMask>(PolynomialsNedelec<dim>::n_polynomials(order),
-                                 std::vector<bool>(dim, true)))
+                                 ComponentMask(std::vector<bool>(dim, true))))
 {
 #ifdef DEBUG_NEDELEC
   deallog << get_name() << std::endl;
index 8d164c2a65a69df2891ec056cf6faa01103c0065..d729595f31093b9c5765d37c95bff73ceec44287 100644 (file)
@@ -30,7 +30,7 @@ FE_NedelecSZ<dim, spacedim>::FE_NedelecSZ(const unsigned int order)
                              FiniteElementData<dim>::Hcurl),
       std::vector<bool>(compute_num_dofs(order), true),
       std::vector<ComponentMask>(compute_num_dofs(order),
-                                 std::vector<bool>(dim, true)))
+                                 ComponentMask(std::vector<bool>(dim, true))))
 {
   Assert(dim >= 2, ExcImpossibleInDim(dim));
 
index 1ea06f4531077dfd5d231c8b2b33447e06e10bda..f0f87ffa3277f441323acd205554ca99c4b71826 100644 (file)
@@ -91,7 +91,7 @@ FE_PyramidPoly<dim, spacedim>::FE_PyramidPoly(
       std::vector<ComponentMask>(
         FiniteElementData<dim>(dpos, ReferenceCells::Pyramid, 1, degree)
           .dofs_per_cell,
-        std::vector<bool>(1, true)))
+        ComponentMask(std::vector<bool>(1, true))))
 {
   AssertDimension(dim, 3);
 
index 68bf4dda839ed059f1fb87ff72972e4d787e7cc4..4ce2c81ec0a38a8aab06a0bbd605d8791ec7ddf2 100644 (file)
@@ -422,7 +422,7 @@ FE_Q_Base<dim, spacedim>::FE_Q_Base(
       poly_space,
       fe_data,
       restriction_is_additive_flags,
-      std::vector<ComponentMask>(1, std::vector<bool>(1, true)))
+      std::vector<ComponentMask>(1, ComponentMask(std::vector<bool>(1, true))))
   , q_degree(dynamic_cast<const TensorProductPolynomialsBubbles<dim> *>(
                &poly_space) != nullptr ?
                this->degree - 1 :
index b73c9c22cd490dc8f02d18000b27a3b30a1cb5d2..61bcd21628ed63d99c906909c5ab0b2ec7618189 100644 (file)
@@ -70,7 +70,7 @@ FE_Q_Hierarchical<dim>::FE_Q_Hierarchical(const unsigned int degree)
                  std::vector<ComponentMask>(
                    FiniteElementData<dim>(get_dpo_vector(degree), 1, degree)
                      .n_dofs_per_cell(),
-                   std::vector<bool>(1, true)))
+                   ComponentMask(std::vector<bool>(1, true))))
   , face_renumber(face_fe_q_hierarchical_to_hierarchic_numbering(degree))
 {
   TensorProductPolynomials<dim> *poly_space_derived_ptr =
index cab89759c079b389d2419ac8c5d9b58b73988b95..02c732418031e3f017cb366d51ee848f3e51ba49 100644 (file)
@@ -32,13 +32,14 @@ template <int dim>
 FE_RannacherTurek<dim>::FE_RannacherTurek(
   const unsigned int order,
   const unsigned int n_face_support_points)
-  : FE_Poly<dim>(PolynomialsRannacherTurek<dim>(),
-                 FiniteElementData<dim>(this->get_dpo_vector(),
-                                        1,
-                                        2,
-                                        FiniteElementData<dim>::L2),
-                 std::vector<bool>(4, false), // restriction not implemented
-                 std::vector<ComponentMask>(4, std::vector<bool>(1, true)))
+  : FE_Poly<dim>(
+      PolynomialsRannacherTurek<dim>(),
+      FiniteElementData<dim>(this->get_dpo_vector(),
+                             1,
+                             2,
+                             FiniteElementData<dim>::L2),
+      std::vector<bool>(4, false), // restriction not implemented
+      std::vector<ComponentMask>(4, ComponentMask(std::vector<bool>(1, true))))
   , order(order)
   , n_face_support_points(n_face_support_points)
 {
index 442438fb59408caf176d5833a32e05d3cfa696f7..bd4024b97028dea4bd73b46d8b9d1d3b34eca590 100644 (file)
@@ -54,7 +54,7 @@ FE_RaviartThomas<dim>::FE_RaviartThomas(const unsigned int deg)
                         true),
       std::vector<ComponentMask>(
         PolynomialsRaviartThomas<dim>::n_polynomials(deg + 1, deg),
-        std::vector<bool>(dim, true)))
+        ComponentMask(std::vector<bool>(dim, true))))
 {
   Assert(dim >= 2, ExcImpossibleInDim(dim));
   const unsigned int n_dofs = this->n_dofs_per_cell();
index e59a7f6f3812660cf8bdaa440f58f9e78547037b..dac93ffd9362694184a545ea208f3e491a9238cc 100644 (file)
@@ -76,7 +76,7 @@ FE_RaviartThomasNodal<dim>::FE_RaviartThomasNodal(const unsigned int degree)
       std::vector<bool>(1, false),
       std::vector<ComponentMask>(
         PolynomialsRaviartThomas<dim>::n_polynomials(degree + 1, degree),
-        std::vector<bool>(dim, true)))
+        ComponentMask(std::vector<bool>(dim, true))))
 {
   Assert(dim >= 2, ExcImpossibleInDim(dim));
 
index afda9e2c873d6a3fd53d3c47ed3456e86707593a..e2fdaad578cfd743e943e9ee86acf4d43e83015f 100644 (file)
@@ -48,7 +48,7 @@ FE_RT_Bubbles<dim>::FE_RT_Bubbles(const unsigned int deg)
                              FiniteElementData<dim>::Hdiv),
       get_ria_vector(deg),
       std::vector<ComponentMask>(PolynomialsRT_Bubbles<dim>::n_polynomials(deg),
-                                 std::vector<bool>(dim, true)))
+                                 ComponentMask(std::vector<bool>(dim, true))))
 {
   Assert(dim >= 2, ExcImpossibleInDim(dim));
   Assert(
index a742b0a60301616d63b0b843c71c84c475e1b7f5..b75e35be4535164edb0bf396f3020e1647a8039b 100644 (file)
@@ -284,7 +284,7 @@ FE_SimplexPoly<dim, spacedim>::FE_SimplexPoly(
       fe_data,
       std::vector<bool>(fe_data.dofs_per_cell),
       std::vector<ComponentMask>(fe_data.dofs_per_cell,
-                                 std::vector<bool>(1, true)))
+                                 ComponentMask(std::vector<bool>(1, true))))
 {
   this->unit_support_points      = unit_support_points;
   this->unit_face_support_points = unit_face_support_points;
index 1450abb5ee2291da8bd3ff49ea4aa8ec2d1de31e..905ce1932d7b2325a62a0204f67de51e57fc1765 100644 (file)
@@ -101,7 +101,7 @@ FE_WedgePoly<dim, spacedim>::FE_WedgePoly(
       std::vector<ComponentMask>(
         FiniteElementData<dim>(dpos, ReferenceCells::Wedge, 1, degree)
           .dofs_per_cell,
-        std::vector<bool>(1, true)))
+        ComponentMask(std::vector<bool>(1, true))))
 {
   AssertDimension(dim, 3);
 
index 011a9cb9bb6404eb3e38a1a95cd745767b249029..b3915516cc6db3f15ef00fadfb556a2a94d1746b 100644 (file)
@@ -1217,7 +1217,7 @@ namespace MGTools
 
             std::vector<bool> tmp(n_blocks, false);
             tmp[i]          = true;
-            block_select[i] = tmp;
+            block_select[i] = BlockMask(tmp);
 
             tasks += Threads::new_task(
               fun_ptr, l, dof_handler, block_select[i], dofs_in_block[i]);
index cbb5f920053e39ee9e7bf0f03efd0ebf8ecfadea..54ad4dfc4ecfc15dd55c4611298ec016d93af7ce 100644 (file)
@@ -504,7 +504,7 @@ void
 PointValueHistory<dim>::add_field_name(const std::string &vector_name,
                                        const unsigned int n_components)
 {
-  std::vector<bool> temp_mask(n_components, true);
+  ComponentMask temp_mask(std::vector<bool>(n_components, true));
   add_field_name(vector_name, temp_mask);
 }
 

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.