]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Be terser in specifying default arguments: ComponentMask. 15898/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Sun, 20 Aug 2023 22:55:39 +0000 (16:55 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Sun, 20 Aug 2023 22:56:55 +0000 (16:56 -0600)
12 files changed:
include/deal.II/dofs/dof_tools.h
include/deal.II/fe/mapping_fe_field.h
include/deal.II/multigrid/mg_constrained_dofs.h
include/deal.II/multigrid/mg_tools.h
include/deal.II/non_matching/coupling.h
include/deal.II/numerics/error_estimator.h
include/deal.II/numerics/point_value_history.h
include/deal.II/numerics/smoothness_estimator.h
include/deal.II/numerics/vector_tools_boundary.h
include/deal.II/numerics/vector_tools_interpolate.h
include/deal.II/particles/generators.h
include/deal.II/particles/utilities.h

index 22d954c0e64c098fd9beec5c79df817de9d4a4f9..bcfafffd047fc7d83c5b5396122aa0720de38c55 100644 (file)
@@ -1046,11 +1046,11 @@ namespace DoFTools
     const FaceIterator &                            face_1,
     const std_cxx20::type_identity_t<FaceIterator> &face_2,
     AffineConstraints<number> &                     constraints,
-    const ComponentMask &            component_mask   = ComponentMask(),
-    const bool                       face_orientation = true,
-    const bool                       face_flip        = false,
-    const bool                       face_rotation    = false,
-    const FullMatrix<double> &       matrix           = FullMatrix<double>(),
+    const ComponentMask &                           component_mask   = {},
+    const bool                                      face_orientation = true,
+    const bool                                      face_flip        = false,
+    const bool                                      face_rotation    = false,
+    const FullMatrix<double> &       matrix = FullMatrix<double>(),
     const std::vector<unsigned int> &first_vector_components =
       std::vector<unsigned int>(),
     const number periodicity_factor = 1.);
@@ -1081,7 +1081,7 @@ namespace DoFTools
     const std::vector<GridTools::PeriodicFacePair<
       typename DoFHandler<dim, spacedim>::cell_iterator>> &periodic_faces,
     AffineConstraints<number> &                            constraints,
-    const ComponentMask &            component_mask = ComponentMask(),
+    const ComponentMask &                                  component_mask = {},
     const std::vector<unsigned int> &first_vector_components =
       std::vector<unsigned int>(),
     const number periodicity_factor = 1.);
@@ -1119,14 +1119,13 @@ namespace DoFTools
    */
   template <int dim, int spacedim, typename number>
   void
-  make_periodicity_constraints(
-    const DoFHandler<dim, spacedim> &dof_handler,
-    const types::boundary_id         b_id1,
-    const types::boundary_id         b_id2,
-    const unsigned int               direction,
-    AffineConstraints<number> &      constraints,
-    const ComponentMask &            component_mask     = ComponentMask(),
-    const number                     periodicity_factor = 1.);
+  make_periodicity_constraints(const DoFHandler<dim, spacedim> &dof_handler,
+                               const types::boundary_id         b_id1,
+                               const types::boundary_id         b_id2,
+                               const unsigned int               direction,
+                               AffineConstraints<number> &      constraints,
+                               const ComponentMask &component_mask     = {},
+                               const number         periodicity_factor = 1.);
 
 
 
@@ -1157,13 +1156,12 @@ namespace DoFTools
    */
   template <int dim, int spacedim, typename number>
   void
-  make_periodicity_constraints(
-    const DoFHandler<dim, spacedim> &dof_handler,
-    const types::boundary_id         b_id,
-    const unsigned int               direction,
-    AffineConstraints<number> &      constraints,
-    const ComponentMask &            component_mask     = ComponentMask(),
-    const number                     periodicity_factor = 1.);
+  make_periodicity_constraints(const DoFHandler<dim, spacedim> &dof_handler,
+                               const types::boundary_id         b_id,
+                               const unsigned int               direction,
+                               AffineConstraints<number> &      constraints,
+                               const ComponentMask &component_mask     = {},
+                               const number         periodicity_factor = 1.);
 
   /**
    * @}
@@ -1317,8 +1315,8 @@ namespace DoFTools
    */
   template <int dim, int spacedim>
   IndexSet
-  extract_boundary_dofs(const DoFHandler<dim, spacedim> &dof_handler,
-                        const ComponentMask &component_mask = ComponentMask(),
+  extract_boundary_dofs(const DoFHandler<dim, spacedim> &   dof_handler,
+                        const ComponentMask &               component_mask = {},
                         const std::set<types::boundary_id> &boundary_ids = {});
 
   /**
@@ -1647,9 +1645,8 @@ namespace DoFTools
    */
   template <int dim, int spacedim>
   std::vector<IndexSet>
-  locally_owned_dofs_per_component(
-    const DoFHandler<dim, spacedim> &dof_handler,
-    const ComponentMask &            components = ComponentMask());
+  locally_owned_dofs_per_component(const DoFHandler<dim, spacedim> &dof_handler,
+                                   const ComponentMask &components = {});
 
   /**
    * For each processor, determine the set of locally owned degrees of freedom
@@ -2278,7 +2275,7 @@ namespace DoFTools
   map_dofs_to_support_points(const Mapping<dim, spacedim> &   mapping,
                              const DoFHandler<dim, spacedim> &dof_handler,
                              std::vector<Point<spacedim>> &   support_points,
-                             const ComponentMask &mask = ComponentMask());
+                             const ComponentMask &            mask = {});
 
   /**
    * Same as the previous function but for the hp-case.
@@ -2289,7 +2286,7 @@ namespace DoFTools
     const hp::MappingCollection<dim, spacedim> &mapping,
     const DoFHandler<dim, spacedim> &           dof_handler,
     std::vector<Point<spacedim>> &              support_points,
-    const ComponentMask &                       mask = ComponentMask());
+    const ComponentMask &                       mask = {});
 
   /**
    * This function is a version of the above map_dofs_to_support_points
@@ -2324,7 +2321,7 @@ namespace DoFTools
   std::map<types::global_dof_index, Point<spacedim>>
   map_dofs_to_support_points(const Mapping<dim, spacedim> &   mapping,
                              const DoFHandler<dim, spacedim> &dof_handler,
-                             const ComponentMask &mask = ComponentMask());
+                             const ComponentMask &            mask = {});
 
   /**
    * Same as the previous function but for the hp-case.
@@ -2334,7 +2331,7 @@ namespace DoFTools
   map_dofs_to_support_points(
     const hp::MappingCollection<dim, spacedim> &mapping,
     const DoFHandler<dim, spacedim> &           dof_handler,
-    const ComponentMask &                       mask = ComponentMask());
+    const ComponentMask &                       mask = {});
 
   /**
    * A version of the function of same name that returns the map via its third
@@ -2347,7 +2344,7 @@ namespace DoFTools
     const Mapping<dim, spacedim> &                      mapping,
     const DoFHandler<dim, spacedim> &                   dof_handler,
     std::map<types::global_dof_index, Point<spacedim>> &support_points,
-    const ComponentMask &                               mask = ComponentMask());
+    const ComponentMask &                               mask = {});
 
   /**
    * A version of the function of same name that returns the map via its third
@@ -2360,7 +2357,7 @@ namespace DoFTools
     const hp::MappingCollection<dim, spacedim> &        mapping,
     const DoFHandler<dim, spacedim> &                   dof_handler,
     std::map<types::global_dof_index, Point<spacedim>> &support_points,
-    const ComponentMask &                               mask = ComponentMask());
+    const ComponentMask &                               mask = {});
 
 
   /**
@@ -2565,7 +2562,7 @@ namespace DoFTools
     const DoFHandler<dim, spacedim> &dof,
     const types::boundary_id         boundary_id,
     AffineConstraints<number> &      zero_boundary_constraints,
-    const ComponentMask &            component_mask = ComponentMask());
+    const ComponentMask &            component_mask = {});
 
   /**
    * Do the same as the previous function, except do it for all parts of the
@@ -2582,7 +2579,7 @@ namespace DoFTools
   make_zero_boundary_constraints(
     const DoFHandler<dim, spacedim> &dof,
     AffineConstraints<number> &      zero_boundary_constraints,
-    const ComponentMask &            component_mask = ComponentMask());
+    const ComponentMask &            component_mask = {});
 
   /**
    * @}
index aa388e5291f0f99f2670209d1cc249b1679b3e5b..73aa6cdfcea06c6c3adac7fa21aabfc904c21ba9 100644 (file)
@@ -114,7 +114,7 @@ public:
    */
   MappingFEField(const DoFHandler<dim, spacedim> &euler_dof_handler,
                  const VectorType &               euler_vector,
-                 const ComponentMask &            mask = ComponentMask());
+                 const ComponentMask &            mask = {});
 
   /**
    * Constructor taking vectors on the multigrid levels rather than the active
@@ -127,7 +127,7 @@ public:
    */
   MappingFEField(const DoFHandler<dim, spacedim> &euler_dof_handler,
                  const std::vector<VectorType> &  euler_vector,
-                 const ComponentMask &            mask = ComponentMask());
+                 const ComponentMask &            mask = {});
 
   /**
    * Constructor with MGLevelObject instead of std::vector, otherwise the same
@@ -138,7 +138,7 @@ public:
    */
   MappingFEField(const DoFHandler<dim, spacedim> &euler_dof_handler,
                  const MGLevelObject<VectorType> &euler_vector,
-                 const ComponentMask &            mask = ComponentMask());
+                 const ComponentMask &            mask = {});
 
   /**
    * Copy constructor.
index 82f2d2711ba835862fe480b71585e52891131b1c..2b33df807d6c53516c17cdd90a563789c7e9ffe3 100644 (file)
@@ -94,7 +94,7 @@ public:
   make_zero_boundary_constraints(
     const DoFHandler<dim, spacedim> &   dof,
     const std::set<types::boundary_id> &boundary_ids,
-    const ComponentMask &               component_mask = ComponentMask());
+    const ComponentMask &               component_mask = {});
 
   /**
    * Add Dirichlet boundary dofs to the internal data structures
index 8e23f0d6c1a5ed6f4bc965da3cfaabd09b76f1c3..63b3c5e5144554f36ff6f723c5e0c60a0afc1ff1 100644 (file)
@@ -226,7 +226,7 @@ namespace MGTools
     const std::map<types::boundary_id, const Function<spacedim> *>
       &                                             function_map,
     std::vector<std::set<types::global_dof_index>> &boundary_indices,
-    const ComponentMask &component_mask = ComponentMask());
+    const ComponentMask &                           component_mask = {});
 
   /**
    * The same function as above, but return an IndexSet rather than a
@@ -241,7 +241,7 @@ namespace MGTools
                      const std::map<types::boundary_id,
                                     const Function<spacedim> *> &function_map,
                      std::vector<IndexSet> &boundary_indices,
-                     const ComponentMask &  component_mask = ComponentMask());
+                     const ComponentMask &  component_mask = {});
 
   /**
    * The same function as above, but return an IndexSet rather than a
@@ -255,7 +255,7 @@ namespace MGTools
   make_boundary_list(const DoFHandler<dim, spacedim> &   mg_dof,
                      const std::set<types::boundary_id> &boundary_ids,
                      std::vector<IndexSet> &             boundary_indices,
-                     const ComponentMask &component_mask = ComponentMask());
+                     const ComponentMask &               component_mask = {});
 
   /**
    * For each level in a multigrid hierarchy, produce an IndexSet that
index 5c1f19d26da190544315580b0e7cf831b8b64ea0..6517f5b56470b45d75bcf258ac3fa752fa657d3d 100644 (file)
@@ -98,8 +98,8 @@ namespace NonMatching
     const Quadrature<dim1> &          quad,
     SparsityPatternBase &             sparsity,
     const AffineConstraints<number> & constraints = AffineConstraints<number>(),
-    const ComponentMask &             space_comps = ComponentMask(),
-    const ComponentMask &             immersed_comps = ComponentMask(),
+    const ComponentMask &             space_comps = {},
+    const ComponentMask &             immersed_comps = {},
     const Mapping<dim0, spacedim> &   space_mapping =
       StaticMappingQ1<dim0, spacedim>::mapping,
     const Mapping<dim1, spacedim> &immersed_mapping =
@@ -122,8 +122,8 @@ namespace NonMatching
     const Quadrature<dim1> &                quad,
     SparsityPatternBase &                   sparsity,
     const AffineConstraints<number> &constraints = AffineConstraints<number>(),
-    const ComponentMask &            space_comps = ComponentMask(),
-    const ComponentMask &            immersed_comps = ComponentMask(),
+    const ComponentMask &            space_comps = {},
+    const ComponentMask &            immersed_comps = {},
     const Mapping<dim1, spacedim> &  immersed_mapping =
       StaticMappingQ1<dim1, spacedim>::mapping,
     const AffineConstraints<number> &immersed_constraints =
@@ -183,8 +183,8 @@ namespace NonMatching
     Matrix &                                              matrix,
     const AffineConstraints<typename Matrix::value_type> &constraints =
       AffineConstraints<typename Matrix::value_type>(),
-    const ComponentMask &          space_comps    = ComponentMask(),
-    const ComponentMask &          immersed_comps = ComponentMask(),
+    const ComponentMask &          space_comps    = {},
+    const ComponentMask &          immersed_comps = {},
     const Mapping<dim0, spacedim> &space_mapping =
       StaticMappingQ1<dim0, spacedim>::mapping,
     const Mapping<dim1, spacedim> &immersed_mapping =
@@ -208,8 +208,8 @@ namespace NonMatching
     Matrix &                                              matrix,
     const AffineConstraints<typename Matrix::value_type> &constraints =
       AffineConstraints<typename Matrix::value_type>(),
-    const ComponentMask &          space_comps    = ComponentMask(),
-    const ComponentMask &          immersed_comps = ComponentMask(),
+    const ComponentMask &          space_comps    = {},
+    const ComponentMask &          immersed_comps = {},
     const Mapping<dim1, spacedim> &immersed_mapping =
       StaticMappingQ1<dim1, spacedim>::mapping,
     const AffineConstraints<typename Matrix::value_type> &immersed_constraints =
@@ -272,8 +272,8 @@ namespace NonMatching
     const Quadrature<dim1> &                quad,
     SparsityPatternBase &                   sparsity,
     const AffineConstraints<Number> &constraints0 = AffineConstraints<Number>(),
-    const ComponentMask &            comps0       = ComponentMask(),
-    const ComponentMask &            comps1       = ComponentMask());
+    const ComponentMask &            comps0       = {},
+    const ComponentMask &            comps1       = {});
 
   /**
    * Create a coupling @ref GlossMassMatrix "mass matrix" for non-matching independent grids,
@@ -335,8 +335,8 @@ namespace NonMatching
     Matrix &                                              matrix,
     const AffineConstraints<typename Matrix::value_type> &constraints0 =
       AffineConstraints<typename Matrix::value_type>(),
-    const ComponentMask &comps0 = ComponentMask(),
-    const ComponentMask &comps1 = ComponentMask());
+    const ComponentMask &comps0 = {},
+    const ComponentMask &comps1 = {});
 } // namespace NonMatching
 DEAL_II_NAMESPACE_CLOSE
 
index 15c9f34b0521a3af9d0462abf047eede9b01b846..689ce02e5930fd603d3b1d67e552d0141dc39205 100644 (file)
@@ -348,7 +348,7 @@ public:
       &                       neumann_bc,
     const ReadVector<Number> &solution,
     Vector<float> &           error,
-    const ComponentMask &     component_mask = ComponentMask(),
+    const ComponentMask &     component_mask = {},
     const Function<spacedim> *coefficients   = nullptr,
     const unsigned int        n_threads      = numbers::invalid_unsigned_int,
     const types::subdomain_id subdomain_id   = numbers::invalid_subdomain_id,
@@ -368,7 +368,7 @@ public:
       &                       neumann_bc,
     const ReadVector<Number> &solution,
     Vector<float> &           error,
-    const ComponentMask &     component_mask = ComponentMask(),
+    const ComponentMask &     component_mask = {},
     const Function<spacedim> *coefficients   = nullptr,
     const unsigned int        n_threads      = numbers::invalid_unsigned_int,
     const types::subdomain_id subdomain_id   = numbers::invalid_subdomain_id,
@@ -398,12 +398,12 @@ public:
       &                                          neumann_bc,
     const ArrayView<const ReadVector<Number> *> &solutions,
     ArrayView<Vector<float> *> &                 errors,
-    const ComponentMask &     component_mask = ComponentMask(),
-    const Function<spacedim> *coefficients   = nullptr,
-    const unsigned int        n_threads      = numbers::invalid_unsigned_int,
-    const types::subdomain_id subdomain_id   = numbers::invalid_subdomain_id,
-    const types::material_id  material_id    = numbers::invalid_material_id,
-    const Strategy            strategy       = cell_diameter_over_24);
+    const ComponentMask &                        component_mask = {},
+    const Function<spacedim> *                   coefficients   = nullptr,
+    const unsigned int        n_threads    = numbers::invalid_unsigned_int,
+    const types::subdomain_id subdomain_id = numbers::invalid_subdomain_id,
+    const types::material_id  material_id  = numbers::invalid_material_id,
+    const Strategy            strategy     = cell_diameter_over_24);
 
   /**
    * Call the @p estimate function, see above, with
@@ -418,12 +418,12 @@ public:
       &                                          neumann_bc,
     const ArrayView<const ReadVector<Number> *> &solutions,
     ArrayView<Vector<float> *> &                 errors,
-    const ComponentMask &     component_mask = ComponentMask(),
-    const Function<spacedim> *coefficients   = nullptr,
-    const unsigned int        n_threads      = numbers::invalid_unsigned_int,
-    const types::subdomain_id subdomain_id   = numbers::invalid_subdomain_id,
-    const types::material_id  material_id    = numbers::invalid_material_id,
-    const Strategy            strategy       = cell_diameter_over_24);
+    const ComponentMask &                        component_mask = {},
+    const Function<spacedim> *                   coefficients   = nullptr,
+    const unsigned int        n_threads    = numbers::invalid_unsigned_int,
+    const types::subdomain_id subdomain_id = numbers::invalid_subdomain_id,
+    const types::material_id  material_id  = numbers::invalid_material_id,
+    const Strategy            strategy     = cell_diameter_over_24);
 
 
   /**
@@ -440,7 +440,7 @@ public:
       &                       neumann_bc,
     const ReadVector<Number> &solution,
     Vector<float> &           error,
-    const ComponentMask &     component_mask = ComponentMask(),
+    const ComponentMask &     component_mask = {},
     const Function<spacedim> *coefficients   = nullptr,
     const unsigned int        n_threads      = numbers::invalid_unsigned_int,
     const types::subdomain_id subdomain_id   = numbers::invalid_subdomain_id,
@@ -461,7 +461,7 @@ public:
       &                       neumann_bc,
     const ReadVector<Number> &solution,
     Vector<float> &           error,
-    const ComponentMask &     component_mask = ComponentMask(),
+    const ComponentMask &     component_mask = {},
     const Function<spacedim> *coefficients   = nullptr,
     const unsigned int        n_threads      = numbers::invalid_unsigned_int,
     const types::subdomain_id subdomain_id   = numbers::invalid_subdomain_id,
@@ -483,12 +483,12 @@ public:
       &                                          neumann_bc,
     const ArrayView<const ReadVector<Number> *> &solutions,
     ArrayView<Vector<float> *> &                 errors,
-    const ComponentMask &     component_mask = ComponentMask(),
-    const Function<spacedim> *coefficients   = nullptr,
-    const unsigned int        n_threads      = numbers::invalid_unsigned_int,
-    const types::subdomain_id subdomain_id   = numbers::invalid_subdomain_id,
-    const types::material_id  material_id    = numbers::invalid_material_id,
-    const Strategy            strategy       = cell_diameter_over_24);
+    const ComponentMask &                        component_mask = {},
+    const Function<spacedim> *                   coefficients   = nullptr,
+    const unsigned int        n_threads    = numbers::invalid_unsigned_int,
+    const types::subdomain_id subdomain_id = numbers::invalid_subdomain_id,
+    const types::material_id  material_id  = numbers::invalid_material_id,
+    const Strategy            strategy     = cell_diameter_over_24);
 
 
   /**
@@ -504,12 +504,12 @@ public:
       &                                          neumann_bc,
     const ArrayView<const ReadVector<Number> *> &solutions,
     ArrayView<Vector<float> *> &                 errors,
-    const ComponentMask &     component_mask = ComponentMask(),
-    const Function<spacedim> *coefficients   = nullptr,
-    const unsigned int        n_threads      = numbers::invalid_unsigned_int,
-    const types::subdomain_id subdomain_id   = numbers::invalid_subdomain_id,
-    const types::material_id  material_id    = numbers::invalid_material_id,
-    const Strategy            strategy       = cell_diameter_over_24);
+    const ComponentMask &                        component_mask = {},
+    const Function<spacedim> *                   coefficients   = nullptr,
+    const unsigned int        n_threads    = numbers::invalid_unsigned_int,
+    const types::subdomain_id subdomain_id = numbers::invalid_subdomain_id,
+    const types::material_id  material_id  = numbers::invalid_material_id,
+    const Strategy            strategy     = cell_diameter_over_24);
 
   /**
    * Exception
@@ -628,7 +628,7 @@ public:
       &                       neumann_bc,
     const ReadVector<Number> &solution,
     Vector<float> &           error,
-    const ComponentMask &     component_mask = ComponentMask(),
+    const ComponentMask &     component_mask = {},
     const Function<spacedim> *coefficient    = nullptr,
     const unsigned int        n_threads      = numbers::invalid_unsigned_int,
     const types::subdomain_id subdomain_id   = numbers::invalid_subdomain_id,
@@ -650,7 +650,7 @@ public:
       &                       neumann_bc,
     const ReadVector<Number> &solution,
     Vector<float> &           error,
-    const ComponentMask &     component_mask = ComponentMask(),
+    const ComponentMask &     component_mask = {},
     const Function<spacedim> *coefficients   = nullptr,
     const unsigned int        n_threads      = numbers::invalid_unsigned_int,
     const types::subdomain_id subdomain_id   = numbers::invalid_subdomain_id,
@@ -682,12 +682,12 @@ public:
       &                                          neumann_bc,
     const ArrayView<const ReadVector<Number> *> &solutions,
     ArrayView<Vector<float> *> &                 errors,
-    const ComponentMask &     component_mask = ComponentMask(),
-    const Function<spacedim> *coefficients   = nullptr,
-    const unsigned int        n_threads      = numbers::invalid_unsigned_int,
-    const types::subdomain_id subdomain_id   = numbers::invalid_subdomain_id,
-    const types::material_id  material_id    = numbers::invalid_material_id,
-    const Strategy            strategy       = cell_diameter_over_24);
+    const ComponentMask &                        component_mask = {},
+    const Function<spacedim> *                   coefficients   = nullptr,
+    const unsigned int        n_threads    = numbers::invalid_unsigned_int,
+    const types::subdomain_id subdomain_id = numbers::invalid_subdomain_id,
+    const types::material_id  material_id  = numbers::invalid_material_id,
+    const Strategy            strategy     = cell_diameter_over_24);
 
 
 
@@ -704,12 +704,12 @@ public:
       &                                          neumann_bc,
     const ArrayView<const ReadVector<Number> *> &solutions,
     ArrayView<Vector<float> *> &                 errors,
-    const ComponentMask &     component_mask = ComponentMask(),
-    const Function<spacedim> *coefficients   = nullptr,
-    const unsigned int        n_threads      = numbers::invalid_unsigned_int,
-    const types::subdomain_id subdomain_id   = numbers::invalid_subdomain_id,
-    const types::material_id  material_id    = numbers::invalid_material_id,
-    const Strategy            strategy       = cell_diameter_over_24);
+    const ComponentMask &                        component_mask = {},
+    const Function<spacedim> *                   coefficients   = nullptr,
+    const unsigned int        n_threads    = numbers::invalid_unsigned_int,
+    const types::subdomain_id subdomain_id = numbers::invalid_subdomain_id,
+    const types::material_id  material_id  = numbers::invalid_material_id,
+    const Strategy            strategy     = cell_diameter_over_24);
 
 
 
@@ -727,7 +727,7 @@ public:
       &                       neumann_bc,
     const ReadVector<Number> &solution,
     Vector<float> &           error,
-    const ComponentMask &     component_mask = ComponentMask(),
+    const ComponentMask &     component_mask = {},
     const Function<spacedim> *coefficients   = nullptr,
     const unsigned int        n_threads      = numbers::invalid_unsigned_int,
     const types::subdomain_id subdomain_id   = numbers::invalid_subdomain_id,
@@ -749,7 +749,7 @@ public:
       &                       neumann_bc,
     const ReadVector<Number> &solution,
     Vector<float> &           error,
-    const ComponentMask &     component_mask = ComponentMask(),
+    const ComponentMask &     component_mask = {},
     const Function<spacedim> *coefficients   = nullptr,
     const unsigned int        n_threads      = numbers::invalid_unsigned_int,
     const types::subdomain_id subdomain_id   = numbers::invalid_subdomain_id,
@@ -772,12 +772,12 @@ public:
       &                                          neumann_bc,
     const ArrayView<const ReadVector<Number> *> &solutions,
     ArrayView<Vector<float> *> &                 errors,
-    const ComponentMask &     component_mask = ComponentMask(),
-    const Function<spacedim> *coefficients   = nullptr,
-    const unsigned int        n_threads      = numbers::invalid_unsigned_int,
-    const types::subdomain_id subdomain_id   = numbers::invalid_subdomain_id,
-    const types::material_id  material_id    = numbers::invalid_material_id,
-    const Strategy            strategy       = cell_diameter_over_24);
+    const ComponentMask &                        component_mask = {},
+    const Function<spacedim> *                   coefficients   = nullptr,
+    const unsigned int        n_threads    = numbers::invalid_unsigned_int,
+    const types::subdomain_id subdomain_id = numbers::invalid_subdomain_id,
+    const types::material_id  material_id  = numbers::invalid_material_id,
+    const Strategy            strategy     = cell_diameter_over_24);
 
 
 
@@ -794,12 +794,12 @@ public:
       &                                          neumann_bc,
     const ArrayView<const ReadVector<Number> *> &solutions,
     ArrayView<Vector<float> *> &                 errors,
-    const ComponentMask &     component_mask = ComponentMask(),
-    const Function<spacedim> *coefficients   = nullptr,
-    const unsigned int        n_threads      = numbers::invalid_unsigned_int,
-    const types::subdomain_id subdomain_id   = numbers::invalid_subdomain_id,
-    const types::material_id  material_id    = numbers::invalid_material_id,
-    const Strategy            strategy       = cell_diameter_over_24);
+    const ComponentMask &                        component_mask = {},
+    const Function<spacedim> *                   coefficients   = nullptr,
+    const unsigned int        n_threads    = numbers::invalid_unsigned_int,
+    const types::subdomain_id subdomain_id = numbers::invalid_subdomain_id,
+    const types::material_id  material_id  = numbers::invalid_material_id,
+    const Strategy            strategy     = cell_diameter_over_24);
 
 
 
index 827e5d902f50c8351c4ce08adb86879b7f28c750..41445f54565c93d42e2f21da48f9726335e5c97a 100644 (file)
@@ -293,7 +293,7 @@ public:
    */
   void
   add_field_name(const std::string &  vector_name,
-                 const ComponentMask &component_mask = ComponentMask());
+                 const ComponentMask &component_mask = {});
 
   /**
    * Put another mnemonic string (and hence @p VectorType) into the class.
index 44aaa043e00f22ca1f7c577243f7d5952ff7c5cb..53f5f5e30eb180b11fdbd24a0740ccf426b9bee0 100644 (file)
@@ -220,9 +220,9 @@ namespace SmoothnessEstimator
       const DoFHandler<dim, spacedim> &  dof_handler,
       const VectorType &                 solution,
       Vector<float> &                    smoothness_indicators,
-      const ComponentMask &coefficients_predicate   = ComponentMask(),
-      const double         smallest_abs_coefficient = 1e-10,
-      const bool           only_flagged_cells       = false);
+      const ComponentMask &              coefficients_predicate   = {},
+      const double                       smallest_abs_coefficient = 1e-10,
+      const bool                         only_flagged_cells       = false);
 
     /**
      * Returns a FESeries::Legendre object for Legendre series expansions with
@@ -458,9 +458,9 @@ namespace SmoothnessEstimator
       const DoFHandler<dim, spacedim> & dof_handler,
       const VectorType &                solution,
       Vector<float> &                   smoothness_indicators,
-      const ComponentMask &coefficients_predicate   = ComponentMask(),
-      const double         smallest_abs_coefficient = 1e-10,
-      const bool           only_flagged_cells       = false);
+      const ComponentMask &             coefficients_predicate   = {},
+      const double                      smallest_abs_coefficient = 1e-10,
+      const bool                        only_flagged_cells       = false);
 
     /**
      * Returns a FESeries::Fourier object for Fourier series expansions with
index f24e0c0afdffc475ec63bacb32624a5fd90e2717..772cf98c7f97a1048a5806613aee78b4027b1d3e 100644 (file)
@@ -155,7 +155,7 @@ namespace VectorTools
     const std::map<types::boundary_id, const Function<spacedim, number> *>
       &                                        function_map,
     std::map<types::global_dof_index, number> &boundary_values,
-    const ComponentMask &component_mask = ComponentMask());
+    const ComponentMask &                      component_mask = {});
 
   /**
    * Like the previous function, but take a mapping collection to go with
@@ -169,7 +169,7 @@ namespace VectorTools
     const std::map<types::boundary_id, const Function<spacedim, number> *>
       &                                        function_map,
     std::map<types::global_dof_index, number> &boundary_values,
-    const ComponentMask &component_mask = ComponentMask());
+    const ComponentMask &                      component_mask = {});
 
   /**
    * Like the previous functions but without Mapping argument, using
@@ -182,7 +182,7 @@ namespace VectorTools
     const std::map<types::boundary_id, const Function<spacedim, number> *>
       &                                        function_map,
     std::map<types::global_dof_index, number> &boundary_values,
-    const ComponentMask &component_mask = ComponentMask());
+    const ComponentMask &                      component_mask = {});
 
   /**
    * Take only one boundary indicator with corresponding boundary function.
@@ -198,7 +198,7 @@ namespace VectorTools
     const types::boundary_id                   boundary_indicator,
     const Function<spacedim, number> &         boundary_function,
     std::map<types::global_dof_index, number> &boundary_values,
-    const ComponentMask &component_mask = ComponentMask());
+    const ComponentMask &                      component_mask = {});
 
   /**
    * Like the previous function, but take a mapping collection to go with
@@ -212,7 +212,7 @@ namespace VectorTools
     const types::boundary_id                    boundary_indicator,
     const Function<spacedim, number> &          boundary_function,
     std::map<types::global_dof_index, number> & boundary_values,
-    const ComponentMask &component_mask = ComponentMask());
+    const ComponentMask &                       component_mask = {});
 
   /**
    * Like the previous functions but without Mapping argument, using
@@ -228,7 +228,7 @@ namespace VectorTools
     const types::boundary_id                   boundary_indicator,
     const Function<spacedim, number> &         boundary_function,
     std::map<types::global_dof_index, number> &boundary_values,
-    const ComponentMask &component_mask = ComponentMask());
+    const ComponentMask &                      component_mask = {});
 
 
   /**
@@ -265,7 +265,7 @@ namespace VectorTools
     const std::map<types::boundary_id, const Function<spacedim, number> *>
       &                        function_map,
     AffineConstraints<number> &constraints,
-    const ComponentMask &      component_mask = ComponentMask());
+    const ComponentMask &      component_mask = {});
 
   /**
    * Like the previous function, but take a mapping collection to go with
@@ -281,7 +281,7 @@ namespace VectorTools
     const std::map<types::boundary_id, const Function<spacedim, number> *>
       &                        function_map,
     AffineConstraints<number> &constraints,
-    const ComponentMask &      component_mask = ComponentMask());
+    const ComponentMask &      component_mask = {});
 
   /**
    * Like the previous functions but without Mapping argument, using
@@ -296,7 +296,7 @@ namespace VectorTools
     const std::map<types::boundary_id, const Function<spacedim, number> *>
       &                        function_map,
     AffineConstraints<number> &constraints,
-    const ComponentMask &      component_mask = ComponentMask());
+    const ComponentMask &      component_mask = {});
 
   /**
    * Take only one boundary indicator with corresponding boundary function.
@@ -314,7 +314,7 @@ namespace VectorTools
     const types::boundary_id          boundary_indicator,
     const Function<spacedim, number> &boundary_function,
     AffineConstraints<number> &       constraints,
-    const ComponentMask &             component_mask = ComponentMask());
+    const ComponentMask &             component_mask = {});
 
   /**
    * Like the previous function, but take a mapping collection to go with
@@ -330,7 +330,7 @@ namespace VectorTools
     const types::boundary_id                    boundary_indicator,
     const Function<spacedim, number> &          boundary_function,
     AffineConstraints<number> &                 constraints,
-    const ComponentMask &component_mask = ComponentMask());
+    const ComponentMask &                       component_mask = {});
 
   /**
    * Like the previous functions but without Mapping argument, using
@@ -348,7 +348,7 @@ namespace VectorTools
     const types::boundary_id          boundary_indicator,
     const Function<spacedim, number> &boundary_function,
     AffineConstraints<number> &       constraints,
-    const ComponentMask &             component_mask = ComponentMask());
+    const ComponentMask &             component_mask = {});
 
 
   /**
index ba32e7aa48717505336d2b5589b08007138ed00f..3bc169223573a7f2ad694377e45e9c57f4dbd73e 100644 (file)
@@ -76,7 +76,7 @@ namespace VectorTools
     const DoFHandler<dim, spacedim> &                          dof,
     const Function<spacedim, typename VectorType::value_type> &function,
     VectorType &                                               vec,
-    const ComponentMask &component_mask = ComponentMask());
+    const ComponentMask &component_mask = {});
 
   /**
    * Same as above but in an hp-context.
@@ -90,7 +90,7 @@ namespace VectorTools
     const DoFHandler<dim, spacedim> &                          dof,
     const Function<spacedim, typename VectorType::value_type> &function,
     VectorType &                                               vec,
-    const ComponentMask &component_mask = ComponentMask());
+    const ComponentMask &component_mask = {});
 
 
   /**
@@ -105,7 +105,7 @@ namespace VectorTools
     const DoFHandler<dim, spacedim> &                          dof,
     const Function<spacedim, typename VectorType::value_type> &function,
     VectorType &                                               vec,
-    const ComponentMask &component_mask = ComponentMask());
+    const ComponentMask &component_mask = {});
 
   /**
    * Interpolate different finite element spaces. The interpolation of vector
@@ -194,7 +194,7 @@ namespace VectorTools
                    const Function<spacedim, typename VectorType::value_type> *>
       &                  function_map,
     VectorType &         dst,
-    const ComponentMask &component_mask = ComponentMask());
+    const ComponentMask &component_mask = {});
 
   /**
    * Compute the interpolation of a @p dof1-function @p u1 to a @p dof2-function
@@ -307,7 +307,7 @@ namespace VectorTools
   DEAL_II_CXX20_REQUIRES(concepts::is_writable_dealii_vector_type<VectorType>)
   void get_position_vector(const DoFHandler<dim, spacedim> &dh,
                            VectorType &                     vector,
-                           const ComponentMask &mask = ComponentMask());
+                           const ComponentMask &            mask = {});
 
   /**
    * Like the above function but also taking @p mapping as argument.
@@ -324,7 +324,7 @@ namespace VectorTools
   void get_position_vector(const Mapping<dim, spacedim> &   mapping,
                            const DoFHandler<dim, spacedim> &dh,
                            VectorType &                     vector,
-                           const ComponentMask &mask = ComponentMask());
+                           const ComponentMask &            mask = {});
 
   /** @} */
 } // namespace VectorTools
index 3429ea7d771615005e36558b8c61b6fd8b918207..790fe85f81016d559f676e5f5cdc158e16bfc6de 100644 (file)
@@ -252,7 +252,7 @@ namespace Particles
 #else
            .ReferenceCell::get_default_linear_mapping<dim, spacedim>()),
 #endif
-      const ComponentMask &                   components = ComponentMask(),
+      const ComponentMask &                   components = {},
       const std::vector<std::vector<double>> &properties = {});
 
     /**
index 65965c933b0b308ac3202693dd740406c6f8dd5f..704c35cf8ca8d4f3a45367524e8855e8875c0637 100644 (file)
@@ -99,7 +99,7 @@ namespace Particles
       SparsityPatternBase &                            sparsity,
       const AffineConstraints<number> &                constraints =
         AffineConstraints<number>(),
-      const ComponentMask &space_comps = ComponentMask());
+      const ComponentMask &space_comps = {});
 
     /**
      * Create an interpolation matrix for particles.
@@ -152,7 +152,7 @@ namespace Particles
       MatrixType &                                     matrix,
       const AffineConstraints<typename MatrixType::value_type> &constraints =
         AffineConstraints<typename MatrixType::value_type>(),
-      const ComponentMask &space_comps = ComponentMask());
+      const ComponentMask &space_comps = {});
 
     /**
      * Given a DoFHandler and a ParticleHandler, interpolate a vector field
@@ -186,7 +186,7 @@ namespace Particles
       const Particles::ParticleHandler<dim, spacedim> &particle_handler,
       const InputVectorType &                          field_vector,
       OutputVectorType &                               interpolated_field,
-      const ComponentMask &field_comps = ComponentMask())
+      const ComponentMask &                            field_comps = {})
     {
       if (particle_handler.n_locally_owned_particles() == 0)
         {

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.