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.);
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.);
*/
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.);
*/
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.);
/**
* @}
*/
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 = {});
/**
*/
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
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.
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
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.
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
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
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 = {});
/**
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
make_zero_boundary_constraints(
const DoFHandler<dim, spacedim> &dof,
AffineConstraints<number> & zero_boundary_constraints,
- const ComponentMask & component_mask = ComponentMask());
+ const ComponentMask & component_mask = {});
/**
* @}
*/
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
*/
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
*/
MappingFEField(const DoFHandler<dim, spacedim> &euler_dof_handler,
const MGLevelObject<VectorType> &euler_vector,
- const ComponentMask & mask = ComponentMask());
+ const ComponentMask & mask = {});
/**
* Copy constructor.
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
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
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
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
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 =
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 =
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 =
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 =
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,
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
& 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,
& 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,
& 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
& 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);
/**
& 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,
& 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,
& 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);
/**
& 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
& 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,
& 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,
& 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);
& 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);
& 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,
& 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,
& 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);
& 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);
*/
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.
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
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
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
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
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.
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
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
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 = {});
/**
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
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
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.
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
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
const types::boundary_id boundary_indicator,
const Function<spacedim, number> &boundary_function,
AffineConstraints<number> & constraints,
- const ComponentMask & component_mask = ComponentMask());
+ const ComponentMask & component_mask = {});
/**
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.
const DoFHandler<dim, spacedim> & dof,
const Function<spacedim, typename VectorType::value_type> &function,
VectorType & vec,
- const ComponentMask &component_mask = ComponentMask());
+ const ComponentMask &component_mask = {});
/**
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
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
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.
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
#else
.ReferenceCell::get_default_linear_mapping<dim, spacedim>()),
#endif
- const ComponentMask & components = ComponentMask(),
+ const ComponentMask & components = {},
const std::vector<std::vector<double>> &properties = {});
/**
SparsityPatternBase & sparsity,
const AffineConstraints<number> & constraints =
AffineConstraints<number>(),
- const ComponentMask &space_comps = ComponentMask());
+ const ComponentMask &space_comps = {});
/**
* Create an interpolation matrix for 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
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)
{