From: Wolfgang Bangerth Date: Sun, 20 Aug 2023 22:55:39 +0000 (-0600) Subject: Be terser in specifying default arguments: ComponentMask. X-Git-Tag: relicensing~576^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=aad743270cef6134dee1558efd73bcb8121bf0f7;p=dealii.git Be terser in specifying default arguments: ComponentMask. --- diff --git a/include/deal.II/dofs/dof_tools.h b/include/deal.II/dofs/dof_tools.h index 22d954c0e6..bcfafffd04 100644 --- a/include/deal.II/dofs/dof_tools.h +++ b/include/deal.II/dofs/dof_tools.h @@ -1046,11 +1046,11 @@ namespace DoFTools const FaceIterator & face_1, const std_cxx20::type_identity_t &face_2, AffineConstraints & constraints, - const ComponentMask & component_mask = ComponentMask(), - const bool face_orientation = true, - const bool face_flip = false, - const bool face_rotation = false, - const FullMatrix & matrix = FullMatrix(), + const ComponentMask & component_mask = {}, + const bool face_orientation = true, + const bool face_flip = false, + const bool face_rotation = false, + const FullMatrix & matrix = FullMatrix(), const std::vector &first_vector_components = std::vector(), const number periodicity_factor = 1.); @@ -1081,7 +1081,7 @@ namespace DoFTools const std::vector::cell_iterator>> &periodic_faces, AffineConstraints & constraints, - const ComponentMask & component_mask = ComponentMask(), + const ComponentMask & component_mask = {}, const std::vector &first_vector_components = std::vector(), const number periodicity_factor = 1.); @@ -1119,14 +1119,13 @@ namespace DoFTools */ template void - make_periodicity_constraints( - const DoFHandler &dof_handler, - const types::boundary_id b_id1, - const types::boundary_id b_id2, - const unsigned int direction, - AffineConstraints & constraints, - const ComponentMask & component_mask = ComponentMask(), - const number periodicity_factor = 1.); + make_periodicity_constraints(const DoFHandler &dof_handler, + const types::boundary_id b_id1, + const types::boundary_id b_id2, + const unsigned int direction, + AffineConstraints & constraints, + const ComponentMask &component_mask = {}, + const number periodicity_factor = 1.); @@ -1157,13 +1156,12 @@ namespace DoFTools */ template void - make_periodicity_constraints( - const DoFHandler &dof_handler, - const types::boundary_id b_id, - const unsigned int direction, - AffineConstraints & constraints, - const ComponentMask & component_mask = ComponentMask(), - const number periodicity_factor = 1.); + make_periodicity_constraints(const DoFHandler &dof_handler, + const types::boundary_id b_id, + const unsigned int direction, + AffineConstraints & constraints, + const ComponentMask &component_mask = {}, + const number periodicity_factor = 1.); /** * @} @@ -1317,8 +1315,8 @@ namespace DoFTools */ template IndexSet - extract_boundary_dofs(const DoFHandler &dof_handler, - const ComponentMask &component_mask = ComponentMask(), + extract_boundary_dofs(const DoFHandler & dof_handler, + const ComponentMask & component_mask = {}, const std::set &boundary_ids = {}); /** @@ -1647,9 +1645,8 @@ namespace DoFTools */ template std::vector - locally_owned_dofs_per_component( - const DoFHandler &dof_handler, - const ComponentMask & components = ComponentMask()); + locally_owned_dofs_per_component(const DoFHandler &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 & mapping, const DoFHandler &dof_handler, std::vector> & 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 &mapping, const DoFHandler & dof_handler, std::vector> & 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> map_dofs_to_support_points(const Mapping & mapping, const DoFHandler &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 &mapping, const DoFHandler & 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 & mapping, const DoFHandler & dof_handler, std::map> &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 & mapping, const DoFHandler & dof_handler, std::map> &support_points, - const ComponentMask & mask = ComponentMask()); + const ComponentMask & mask = {}); /** @@ -2565,7 +2562,7 @@ namespace DoFTools const DoFHandler &dof, const types::boundary_id boundary_id, AffineConstraints & 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 &dof, AffineConstraints & zero_boundary_constraints, - const ComponentMask & component_mask = ComponentMask()); + const ComponentMask & component_mask = {}); /** * @} diff --git a/include/deal.II/fe/mapping_fe_field.h b/include/deal.II/fe/mapping_fe_field.h index aa388e5291..73aa6cdfce 100644 --- a/include/deal.II/fe/mapping_fe_field.h +++ b/include/deal.II/fe/mapping_fe_field.h @@ -114,7 +114,7 @@ public: */ MappingFEField(const DoFHandler &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 &euler_dof_handler, const std::vector & 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 &euler_dof_handler, const MGLevelObject &euler_vector, - const ComponentMask & mask = ComponentMask()); + const ComponentMask & mask = {}); /** * Copy constructor. diff --git a/include/deal.II/multigrid/mg_constrained_dofs.h b/include/deal.II/multigrid/mg_constrained_dofs.h index 82f2d2711b..2b33df807d 100644 --- a/include/deal.II/multigrid/mg_constrained_dofs.h +++ b/include/deal.II/multigrid/mg_constrained_dofs.h @@ -94,7 +94,7 @@ public: make_zero_boundary_constraints( const DoFHandler & dof, const std::set &boundary_ids, - const ComponentMask & component_mask = ComponentMask()); + const ComponentMask & component_mask = {}); /** * Add Dirichlet boundary dofs to the internal data structures diff --git a/include/deal.II/multigrid/mg_tools.h b/include/deal.II/multigrid/mg_tools.h index 8e23f0d6c1..63b3c5e514 100644 --- a/include/deal.II/multigrid/mg_tools.h +++ b/include/deal.II/multigrid/mg_tools.h @@ -226,7 +226,7 @@ namespace MGTools const std::map *> & function_map, std::vector> &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 *> &function_map, std::vector &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 & mg_dof, const std::set &boundary_ids, std::vector & boundary_indices, - const ComponentMask &component_mask = ComponentMask()); + const ComponentMask & component_mask = {}); /** * For each level in a multigrid hierarchy, produce an IndexSet that diff --git a/include/deal.II/non_matching/coupling.h b/include/deal.II/non_matching/coupling.h index 5c1f19d26d..6517f5b564 100644 --- a/include/deal.II/non_matching/coupling.h +++ b/include/deal.II/non_matching/coupling.h @@ -98,8 +98,8 @@ namespace NonMatching const Quadrature & quad, SparsityPatternBase & sparsity, const AffineConstraints & constraints = AffineConstraints(), - const ComponentMask & space_comps = ComponentMask(), - const ComponentMask & immersed_comps = ComponentMask(), + const ComponentMask & space_comps = {}, + const ComponentMask & immersed_comps = {}, const Mapping & space_mapping = StaticMappingQ1::mapping, const Mapping &immersed_mapping = @@ -122,8 +122,8 @@ namespace NonMatching const Quadrature & quad, SparsityPatternBase & sparsity, const AffineConstraints &constraints = AffineConstraints(), - const ComponentMask & space_comps = ComponentMask(), - const ComponentMask & immersed_comps = ComponentMask(), + const ComponentMask & space_comps = {}, + const ComponentMask & immersed_comps = {}, const Mapping & immersed_mapping = StaticMappingQ1::mapping, const AffineConstraints &immersed_constraints = @@ -183,8 +183,8 @@ namespace NonMatching Matrix & matrix, const AffineConstraints &constraints = AffineConstraints(), - const ComponentMask & space_comps = ComponentMask(), - const ComponentMask & immersed_comps = ComponentMask(), + const ComponentMask & space_comps = {}, + const ComponentMask & immersed_comps = {}, const Mapping &space_mapping = StaticMappingQ1::mapping, const Mapping &immersed_mapping = @@ -208,8 +208,8 @@ namespace NonMatching Matrix & matrix, const AffineConstraints &constraints = AffineConstraints(), - const ComponentMask & space_comps = ComponentMask(), - const ComponentMask & immersed_comps = ComponentMask(), + const ComponentMask & space_comps = {}, + const ComponentMask & immersed_comps = {}, const Mapping &immersed_mapping = StaticMappingQ1::mapping, const AffineConstraints &immersed_constraints = @@ -272,8 +272,8 @@ namespace NonMatching const Quadrature & quad, SparsityPatternBase & sparsity, const AffineConstraints &constraints0 = AffineConstraints(), - 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 &constraints0 = AffineConstraints(), - const ComponentMask &comps0 = ComponentMask(), - const ComponentMask &comps1 = ComponentMask()); + const ComponentMask &comps0 = {}, + const ComponentMask &comps1 = {}); } // namespace NonMatching DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/numerics/error_estimator.h b/include/deal.II/numerics/error_estimator.h index 15c9f34b05..689ce02e59 100644 --- a/include/deal.II/numerics/error_estimator.h +++ b/include/deal.II/numerics/error_estimator.h @@ -348,7 +348,7 @@ public: & neumann_bc, const ReadVector &solution, Vector & error, - const ComponentMask & component_mask = ComponentMask(), + const ComponentMask & component_mask = {}, const Function *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 &solution, Vector & error, - const ComponentMask & component_mask = ComponentMask(), + const ComponentMask & component_mask = {}, const Function *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 *> &solutions, ArrayView *> & errors, - const ComponentMask & component_mask = ComponentMask(), - const Function *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 * 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 *> &solutions, ArrayView *> & errors, - const ComponentMask & component_mask = ComponentMask(), - const Function *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 * 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 &solution, Vector & error, - const ComponentMask & component_mask = ComponentMask(), + const ComponentMask & component_mask = {}, const Function *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 &solution, Vector & error, - const ComponentMask & component_mask = ComponentMask(), + const ComponentMask & component_mask = {}, const Function *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 *> &solutions, ArrayView *> & errors, - const ComponentMask & component_mask = ComponentMask(), - const Function *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 * 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 *> &solutions, ArrayView *> & errors, - const ComponentMask & component_mask = ComponentMask(), - const Function *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 * 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 &solution, Vector & error, - const ComponentMask & component_mask = ComponentMask(), + const ComponentMask & component_mask = {}, const Function *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 &solution, Vector & error, - const ComponentMask & component_mask = ComponentMask(), + const ComponentMask & component_mask = {}, const Function *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 *> &solutions, ArrayView *> & errors, - const ComponentMask & component_mask = ComponentMask(), - const Function *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 * 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 *> &solutions, ArrayView *> & errors, - const ComponentMask & component_mask = ComponentMask(), - const Function *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 * 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 &solution, Vector & error, - const ComponentMask & component_mask = ComponentMask(), + const ComponentMask & component_mask = {}, const Function *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 &solution, Vector & error, - const ComponentMask & component_mask = ComponentMask(), + const ComponentMask & component_mask = {}, const Function *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 *> &solutions, ArrayView *> & errors, - const ComponentMask & component_mask = ComponentMask(), - const Function *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 * 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 *> &solutions, ArrayView *> & errors, - const ComponentMask & component_mask = ComponentMask(), - const Function *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 * 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); diff --git a/include/deal.II/numerics/point_value_history.h b/include/deal.II/numerics/point_value_history.h index 827e5d902f..41445f5456 100644 --- a/include/deal.II/numerics/point_value_history.h +++ b/include/deal.II/numerics/point_value_history.h @@ -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. diff --git a/include/deal.II/numerics/smoothness_estimator.h b/include/deal.II/numerics/smoothness_estimator.h index 44aaa043e0..53f5f5e30e 100644 --- a/include/deal.II/numerics/smoothness_estimator.h +++ b/include/deal.II/numerics/smoothness_estimator.h @@ -220,9 +220,9 @@ namespace SmoothnessEstimator const DoFHandler & dof_handler, const VectorType & solution, Vector & 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 & dof_handler, const VectorType & solution, Vector & 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 diff --git a/include/deal.II/numerics/vector_tools_boundary.h b/include/deal.II/numerics/vector_tools_boundary.h index f24e0c0afd..772cf98c7f 100644 --- a/include/deal.II/numerics/vector_tools_boundary.h +++ b/include/deal.II/numerics/vector_tools_boundary.h @@ -155,7 +155,7 @@ namespace VectorTools const std::map *> & function_map, std::map &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 *> & function_map, std::map &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 *> & function_map, std::map &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 & boundary_function, std::map &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 & boundary_function, std::map & 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 & boundary_function, std::map &boundary_values, - const ComponentMask &component_mask = ComponentMask()); + const ComponentMask & component_mask = {}); /** @@ -265,7 +265,7 @@ namespace VectorTools const std::map *> & function_map, AffineConstraints &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 *> & function_map, AffineConstraints &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 *> & function_map, AffineConstraints &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 &boundary_function, AffineConstraints & 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 & boundary_function, AffineConstraints & 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 &boundary_function, AffineConstraints & constraints, - const ComponentMask & component_mask = ComponentMask()); + const ComponentMask & component_mask = {}); /** diff --git a/include/deal.II/numerics/vector_tools_interpolate.h b/include/deal.II/numerics/vector_tools_interpolate.h index ba32e7aa48..3bc1692235 100644 --- a/include/deal.II/numerics/vector_tools_interpolate.h +++ b/include/deal.II/numerics/vector_tools_interpolate.h @@ -76,7 +76,7 @@ namespace VectorTools const DoFHandler & dof, const Function &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 & dof, const Function &function, VectorType & vec, - const ComponentMask &component_mask = ComponentMask()); + const ComponentMask &component_mask = {}); /** @@ -105,7 +105,7 @@ namespace VectorTools const DoFHandler & dof, const Function &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 *> & 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) void get_position_vector(const DoFHandler &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 & mapping, const DoFHandler &dh, VectorType & vector, - const ComponentMask &mask = ComponentMask()); + const ComponentMask & mask = {}); /** @} */ } // namespace VectorTools diff --git a/include/deal.II/particles/generators.h b/include/deal.II/particles/generators.h index 3429ea7d77..790fe85f81 100644 --- a/include/deal.II/particles/generators.h +++ b/include/deal.II/particles/generators.h @@ -252,7 +252,7 @@ namespace Particles #else .ReferenceCell::get_default_linear_mapping()), #endif - const ComponentMask & components = ComponentMask(), + const ComponentMask & components = {}, const std::vector> &properties = {}); /** diff --git a/include/deal.II/particles/utilities.h b/include/deal.II/particles/utilities.h index 65965c933b..704c35cf8c 100644 --- a/include/deal.II/particles/utilities.h +++ b/include/deal.II/particles/utilities.h @@ -99,7 +99,7 @@ namespace Particles SparsityPatternBase & sparsity, const AffineConstraints & constraints = AffineConstraints(), - 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 &constraints = AffineConstraints(), - 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 &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) {