From: Daniel Arndt Date: Tue, 20 Jun 2023 21:19:27 +0000 (-0400) Subject: Mark some constructors as explicit X-Git-Tag: relicensing~757^2~4 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=f4df1b75c2a45cfe73b7f8043682ba89ea836aba;p=dealii.git Mark some constructors as explicit --- diff --git a/include/deal.II/base/conditional_ostream.h b/include/deal.II/base/conditional_ostream.h index c05c2c67b1..d3827e17ea 100644 --- a/include/deal.II/base/conditional_ostream.h +++ b/include/deal.II/base/conditional_ostream.h @@ -85,7 +85,7 @@ public: * based on which writes are actually forwarded. Per default the condition * of an object is active. */ - ConditionalOStream(std::ostream &stream, const bool active = true); + explicit ConditionalOStream(std::ostream &stream, const bool active = true); /** * Depending on the active flag set the condition of this stream to diff --git a/include/deal.II/base/table_handler.h b/include/deal.II/base/table_handler.h index a55bc25941..a3e60825a8 100644 --- a/include/deal.II/base/table_handler.h +++ b/include/deal.II/base/table_handler.h @@ -64,7 +64,7 @@ namespace internal * t. */ template - TableEntry(const T &t); + explicit TableEntry(const T &t); /** * Return the value stored by this object. The template type T must be one @@ -634,7 +634,7 @@ protected: /** * Constructor. */ - Column(const std::string &tex_caption); + explicit Column(const std::string &tex_caption); /** * Pad this column with default constructed elements to the number of rows diff --git a/include/deal.II/fe/block_mask.h b/include/deal.II/fe/block_mask.h index c27db0e846..ca6fa0e898 100644 --- a/include/deal.II/fe/block_mask.h +++ b/include/deal.II/fe/block_mask.h @@ -89,7 +89,7 @@ public: * the given vector is zero, then this interpreted as the case where * every block is selected. */ - BlockMask(const std::vector &block_mask); + explicit BlockMask(const std::vector &block_mask); /** * Initialize the block mask with a number of elements that are either all @@ -345,7 +345,7 @@ BlockMask::operator|(const BlockMask &mask) const for (unsigned int i = 0; i < block_mask.size(); ++i) new_mask[i] = (block_mask[i] || mask.block_mask[i]); - return new_mask; + return BlockMask(new_mask); } } @@ -368,7 +368,7 @@ BlockMask::operator&(const BlockMask &mask) const for (unsigned int i = 0; i < block_mask.size(); ++i) new_mask[i] = (block_mask[i] && mask.block_mask[i]); - return new_mask; + return BlockMask(new_mask); } } diff --git a/include/deal.II/fe/component_mask.h b/include/deal.II/fe/component_mask.h index d2d03218f8..37209e7225 100644 --- a/include/deal.II/fe/component_mask.h +++ b/include/deal.II/fe/component_mask.h @@ -98,7 +98,7 @@ public: * length of the given vector is zero, then this interpreted as the case * where every component is selected. */ - ComponentMask(const std::vector &component_mask); + explicit ComponentMask(const std::vector &component_mask); /** * Initialize the component mask with a number of elements that are either @@ -375,7 +375,7 @@ ComponentMask::operator|(const ComponentMask &mask) const for (unsigned int i = 0; i < component_mask.size(); ++i) new_mask[i] = (component_mask[i] || mask.component_mask[i]); - return new_mask; + return ComponentMask(new_mask); } } @@ -398,7 +398,7 @@ ComponentMask::operator&(const ComponentMask &mask) const for (unsigned int i = 0; i < component_mask.size(); ++i) new_mask[i] = (component_mask[i] && mask.component_mask[i]); - return new_mask; + return ComponentMask(new_mask); } } diff --git a/include/deal.II/lac/slepc_solver.h b/include/deal.II/lac/slepc_solver.h index 1bbfe87a7f..56c893749b 100644 --- a/include/deal.II/lac/slepc_solver.h +++ b/include/deal.II/lac/slepc_solver.h @@ -404,9 +404,10 @@ namespace SLEPcWrappers * computations are parallelized. By default, this carries the same * behavior as the PETScWrappers, but you can change that. */ - SolverKrylovSchur(SolverControl & cn, - const MPI_Comm mpi_communicator = PETSC_COMM_SELF, - const AdditionalData &data = AdditionalData()); + explicit SolverKrylovSchur( + SolverControl & cn, + const MPI_Comm mpi_communicator = PETSC_COMM_SELF, + const AdditionalData &data = AdditionalData()); protected: /** @@ -442,7 +443,7 @@ namespace SLEPcWrappers * Constructor. By default, set the option of delayed * reorthogonalization to false, i.e. don't do it. */ - AdditionalData(const bool delayed_reorthogonalization = false); + explicit AdditionalData(const bool delayed_reorthogonalization = false); /** * Flag for delayed reorthogonalization. @@ -455,9 +456,9 @@ namespace SLEPcWrappers * computations are parallelized. By default, this carries the same * behavior as the PETScWrappers, but you can change that. */ - SolverArnoldi(SolverControl & cn, - const MPI_Comm mpi_communicator = PETSC_COMM_SELF, - const AdditionalData &data = AdditionalData()); + explicit SolverArnoldi(SolverControl &cn, + const MPI_Comm mpi_communicator = PETSC_COMM_SELF, + const AdditionalData &data = AdditionalData()); protected: /** @@ -498,7 +499,7 @@ namespace SLEPcWrappers * Constructor. By default sets the type of reorthogonalization used * during the Lanczos iteration to full. */ - AdditionalData( + explicit AdditionalData( const EPSLanczosReorthogType r = EPS_LANCZOS_REORTHOG_FULL); }; @@ -507,9 +508,9 @@ namespace SLEPcWrappers * computations are parallelized. By default, this carries the same * behavior as the PETScWrappers, but you can change that. */ - SolverLanczos(SolverControl & cn, - const MPI_Comm mpi_communicator = PETSC_COMM_SELF, - const AdditionalData &data = AdditionalData()); + explicit SolverLanczos(SolverControl &cn, + const MPI_Comm mpi_communicator = PETSC_COMM_SELF, + const AdditionalData &data = AdditionalData()); protected: /** @@ -547,9 +548,9 @@ namespace SLEPcWrappers * computations are parallelized. By default, this carries the same * behavior as the PETScWrappers, but you can change that. */ - SolverPower(SolverControl & cn, - const MPI_Comm mpi_communicator = PETSC_COMM_SELF, - const AdditionalData &data = AdditionalData()); + explicit SolverPower(SolverControl &cn, + const MPI_Comm mpi_communicator = PETSC_COMM_SELF, + const AdditionalData &data = AdditionalData()); protected: /** @@ -589,7 +590,7 @@ namespace SLEPcWrappers /** * Constructor. By default set double_expansion to false. */ - AdditionalData(bool double_expansion = false); + explicit AdditionalData(bool double_expansion = false); }; /** @@ -597,9 +598,10 @@ namespace SLEPcWrappers * computations are parallelized. By default, this carries the same * behavior as the PETScWrappers, but you can change that. */ - SolverGeneralizedDavidson(SolverControl &cn, - const MPI_Comm mpi_communicator = PETSC_COMM_SELF, - const AdditionalData &data = AdditionalData()); + explicit SolverGeneralizedDavidson( + SolverControl & cn, + const MPI_Comm mpi_communicator = PETSC_COMM_SELF, + const AdditionalData &data = AdditionalData()); protected: /** @@ -637,9 +639,10 @@ namespace SLEPcWrappers * computations are parallelized. By default, this carries the same * behavior as the PETScWrappers, but you can change that. */ - SolverJacobiDavidson(SolverControl &cn, - const MPI_Comm mpi_communicator = PETSC_COMM_SELF, - const AdditionalData &data = AdditionalData()); + explicit SolverJacobiDavidson( + SolverControl & cn, + const MPI_Comm mpi_communicator = PETSC_COMM_SELF, + const AdditionalData &data = AdditionalData()); protected: /** @@ -677,9 +680,9 @@ namespace SLEPcWrappers * computations are parallelized. By default, this carries the same * behavior as the PETScWrappers, but you can change that. */ - SolverLAPACK(SolverControl & cn, - const MPI_Comm mpi_communicator = PETSC_COMM_SELF, - const AdditionalData &data = AdditionalData()); + explicit SolverLAPACK(SolverControl &cn, + const MPI_Comm mpi_communicator = PETSC_COMM_SELF, + const AdditionalData &data = AdditionalData()); protected: /** diff --git a/include/deal.II/lac/slepc_spectral_transformation.h b/include/deal.II/lac/slepc_spectral_transformation.h index 73c5cbe25c..378571d3d2 100644 --- a/include/deal.II/lac/slepc_spectral_transformation.h +++ b/include/deal.II/lac/slepc_spectral_transformation.h @@ -79,7 +79,7 @@ namespace SLEPcWrappers /** * Constructor. */ - TransformationBase(const MPI_Comm mpi_communicator); + explicit TransformationBase(const MPI_Comm mpi_communicator); public: /** @@ -132,7 +132,7 @@ namespace SLEPcWrappers /** * Constructor. By default, set the shift parameter to zero. */ - AdditionalData(const double shift_parameter = 0); + explicit AdditionalData(const double shift_parameter = 0); /** * Shift parameter. @@ -144,8 +144,8 @@ namespace SLEPcWrappers /** * Constructor. */ - TransformationShift(const MPI_Comm mpi_communicator, - const AdditionalData &data = AdditionalData()); + explicit TransformationShift(const MPI_Comm mpi_communicator, + const AdditionalData &data = AdditionalData()); protected: @@ -172,7 +172,7 @@ namespace SLEPcWrappers /** * Constructor. By default, set the shift parameter to zero. */ - AdditionalData(const double shift_parameter = 0); + explicit AdditionalData(const double shift_parameter = 0); /** * Shift parameter. @@ -184,8 +184,9 @@ namespace SLEPcWrappers /** * Constructor. */ - TransformationShiftInvert(const MPI_Comm mpi_communicator, - const AdditionalData &data = AdditionalData()); + explicit TransformationShiftInvert( + const MPI_Comm mpi_communicator, + const AdditionalData &data = AdditionalData()); protected: /** @@ -220,7 +221,7 @@ namespace SLEPcWrappers /** * Constructor. By default, set the shift parameter to zero. */ - AdditionalData(const double shift_parameter = 0); + explicit AdditionalData(const double shift_parameter = 0); /** * Shift parameter. @@ -232,7 +233,7 @@ namespace SLEPcWrappers /** * Constructor. */ - TransformationSpectrumFolding( + explicit TransformationSpectrumFolding( const MPI_Comm mpi_communicator, const AdditionalData &data = AdditionalData()); @@ -259,8 +260,8 @@ namespace SLEPcWrappers /** * Constructor. Requires two shift parameters */ - AdditionalData(const double shift_parameter = 0, - const double antishift_parameter = 0); + explicit AdditionalData(const double shift_parameter = 0, + const double antishift_parameter = 0); /** * Shift parameter. @@ -277,8 +278,9 @@ namespace SLEPcWrappers /** * Constructor. */ - TransformationCayley(const MPI_Comm mpi_communicator, - const AdditionalData &data = AdditionalData()); + explicit TransformationCayley( + const MPI_Comm mpi_communicator, + const AdditionalData &data = AdditionalData()); protected: /** diff --git a/include/deal.II/lac/solver_control.h b/include/deal.II/lac/solver_control.h index 45508e12d5..c7e263507f 100644 --- a/include/deal.II/lac/solver_control.h +++ b/include/deal.II/lac/solver_control.h @@ -439,7 +439,7 @@ public: * Initialize with a SolverControl object. The result will emulate * SolverControl by setting @p reduce to zero. */ - ReductionControl(const SolverControl &c); + explicit ReductionControl(const SolverControl &c); /** * Assign a SolverControl object to ReductionControl. The result of the @@ -525,7 +525,7 @@ public: * Initialize with a SolverControl object. The result will emulate * SolverControl by setting the reduction target to zero. */ - IterationNumberControl(const SolverControl &c); + explicit IterationNumberControl(const SolverControl &c); /** * Assign a SolverControl object to ReductionControl. The result of the @@ -581,7 +581,7 @@ public: * Initialize with a SolverControl object. The result will emulate * SolverControl by setting @p n_consecutive_iterations to one. */ - ConsecutiveControl(const SolverControl &c); + explicit ConsecutiveControl(const SolverControl &c); /** * Assign a SolverControl object to ConsecutiveControl. The result of the diff --git a/source/dofs/dof_tools.cc b/source/dofs/dof_tools.cc index bd2f44dae1..3b0d186994 100644 --- a/source/dofs/dof_tools.cc +++ b/source/dofs/dof_tools.cc @@ -1724,7 +1724,7 @@ namespace DoFTools std::vector component_association(dof_handler.n_dofs()); internal::get_component_association(dof_handler, - std::vector(), + ComponentMask(std::vector()), component_association); for (unsigned int c = 0; c < dof_handler.get_fe(0).n_components(); ++c) diff --git a/source/fe/fe.cc b/source/fe/fe.cc index 06c10664de..7aa5c5965a 100644 --- a/source/fe/fe.cc +++ b/source/fe/fe.cc @@ -401,7 +401,7 @@ FiniteElement::component_mask( std::vector mask(this->n_components(), false); mask[scalar.component] = true; - return mask; + return ComponentMask(mask); } @@ -423,7 +423,7 @@ FiniteElement::component_mask( c < vector.first_vector_component + dim; ++c) mask[c] = true; - return mask; + return ComponentMask(mask); } @@ -447,7 +447,7 @@ FiniteElement::component_mask( SymmetricTensor<2, dim>::n_independent_components; ++c) mask[c] = true; - return mask; + return ComponentMask(mask); } @@ -468,7 +468,7 @@ FiniteElement::component_mask(const BlockMask &block_mask) const if (block_mask[component_to_block_index(c)] == true) component_mask[c] = true; - return component_mask; + return ComponentMask(component_mask); } @@ -554,7 +554,7 @@ FiniteElement::block_mask( } - return block_mask; + return BlockMask(block_mask); } diff --git a/source/fe/fe_abf.cc b/source/fe/fe_abf.cc index d367dd87b6..086df3c49e 100644 --- a/source/fe/fe_abf.cc +++ b/source/fe/fe_abf.cc @@ -51,7 +51,7 @@ FE_ABF::FE_ABF(const unsigned int deg) FiniteElementData::Hdiv), std::vector(PolynomialsABF::n_polynomials(deg), true), std::vector(PolynomialsABF::n_polynomials(deg), - std::vector(dim, true))) + ComponentMask(std::vector(dim, true)))) , rt_order(deg) { Assert(dim >= 2, ExcImpossibleInDim(dim)); diff --git a/source/fe/fe_bdm.cc b/source/fe/fe_bdm.cc index d86b0c953b..0d960f5c81 100644 --- a/source/fe/fe_bdm.cc +++ b/source/fe/fe_bdm.cc @@ -50,7 +50,7 @@ FE_BDM::FE_BDM(const unsigned int deg) FiniteElementData::Hdiv), get_ria_vector(deg), std::vector(PolynomialsBDM::n_polynomials(deg), - std::vector(dim, true))) + ComponentMask(std::vector(dim, true)))) { Assert(dim >= 2, ExcImpossibleInDim(dim)); Assert( diff --git a/source/fe/fe_bernardi_raugel.cc b/source/fe/fe_bernardi_raugel.cc index 393ffd176a..c07a321a43 100644 --- a/source/fe/fe_bernardi_raugel.cc +++ b/source/fe/fe_bernardi_raugel.cc @@ -51,7 +51,7 @@ FE_BernardiRaugel::FE_BernardiRaugel(const unsigned int p) std::vector(PolynomialsBernardiRaugel::n_polynomials(p), true), std::vector(PolynomialsBernardiRaugel::n_polynomials( p), - std::vector(dim, true))) + ComponentMask(std::vector(dim, true)))) { Assert(dim == 2 || dim == 3, ExcImpossibleInDim(dim)); Assert(p == 1, ExcMessage("Only BR1 elements are available")); diff --git a/source/fe/fe_dgp.cc b/source/fe/fe_dgp.cc index 724bd4a401..dad2d33c31 100644 --- a/source/fe/fe_dgp.cc +++ b/source/fe/fe_dgp.cc @@ -40,7 +40,7 @@ FE_DGP::FE_DGP(const unsigned int degree) std::vector( FiniteElementData(get_dpo_vector(degree), 1, degree) .n_dofs_per_cell(), - std::vector(1, true))) + ComponentMask(std::vector(1, true)))) { // Reinit the vectors of restriction and prolongation matrices to the right // sizes diff --git a/source/fe/fe_dgp_monomial.cc b/source/fe/fe_dgp_monomial.cc index b632ee5341..44b2a62e17 100644 --- a/source/fe/fe_dgp_monomial.cc +++ b/source/fe/fe_dgp_monomial.cc @@ -142,7 +142,7 @@ FE_DGPMonomial::FE_DGPMonomial(const unsigned int degree) std::vector( FiniteElementData(get_dpo_vector(degree), 1, degree) .n_dofs_per_cell(), - std::vector(1, true))) + ComponentMask(std::vector(1, true)))) { Assert(this->poly_space->n() == this->n_dofs_per_cell(), ExcInternalError()); Assert(this->poly_space->degree() == this->degree, ExcInternalError()); diff --git a/source/fe/fe_dgp_nonparametric.cc b/source/fe/fe_dgp_nonparametric.cc index bf5e7db2e1..66d1f2d77c 100644 --- a/source/fe/fe_dgp_nonparametric.cc +++ b/source/fe/fe_dgp_nonparametric.cc @@ -48,7 +48,7 @@ FE_DGPNonparametric::FE_DGPNonparametric( std::vector( FiniteElementData(get_dpo_vector(degree), 1, degree) .n_dofs_per_cell(), - std::vector(1, true))) + ComponentMask(std::vector(1, true)))) , polynomial_space(Polynomials::Legendre::generate_complete_basis(degree)) { const unsigned int n_dofs = this->n_dofs_per_cell(); diff --git a/source/fe/fe_dgq.cc b/source/fe/fe_dgq.cc index 9ec53290f7..ff25d2e10a 100644 --- a/source/fe/fe_dgq.cc +++ b/source/fe/fe_dgq.cc @@ -79,7 +79,7 @@ FE_DGQ::FE_DGQ(const unsigned int degree) std::vector( FiniteElementData(get_dpo_vector(degree), 1, degree) .n_dofs_per_cell(), - std::vector(1, true))) + ComponentMask(std::vector(1, true)))) { // Compute support points, which are the tensor product of the Lagrange // interpolation points in the constructor. @@ -116,7 +116,7 @@ FE_DGQ::FE_DGQ( 1, polynomials.size() - 1) .n_dofs_per_cell(), - std::vector(1, true))) + ComponentMask(std::vector(1, true)))) { // No support points can be defined in general. Derived classes might define // support points like the class FE_DGQArbitraryNodes diff --git a/source/fe/fe_nedelec.cc b/source/fe/fe_nedelec.cc index 4a2bb5757c..8a7a985274 100644 --- a/source/fe/fe_nedelec.cc +++ b/source/fe/fe_nedelec.cc @@ -76,7 +76,7 @@ FE_Nedelec::FE_Nedelec(const unsigned int order) FiniteElementData::Hcurl), std::vector(PolynomialsNedelec::n_polynomials(order), true), std::vector(PolynomialsNedelec::n_polynomials(order), - std::vector(dim, true))) + ComponentMask(std::vector(dim, true)))) { #ifdef DEBUG_NEDELEC deallog << get_name() << std::endl; diff --git a/source/fe/fe_nedelec_sz.cc b/source/fe/fe_nedelec_sz.cc index 8d164c2a65..d729595f31 100644 --- a/source/fe/fe_nedelec_sz.cc +++ b/source/fe/fe_nedelec_sz.cc @@ -30,7 +30,7 @@ FE_NedelecSZ::FE_NedelecSZ(const unsigned int order) FiniteElementData::Hcurl), std::vector(compute_num_dofs(order), true), std::vector(compute_num_dofs(order), - std::vector(dim, true))) + ComponentMask(std::vector(dim, true)))) { Assert(dim >= 2, ExcImpossibleInDim(dim)); diff --git a/source/fe/fe_pyramid_p.cc b/source/fe/fe_pyramid_p.cc index 1ea06f4531..f0f87ffa32 100644 --- a/source/fe/fe_pyramid_p.cc +++ b/source/fe/fe_pyramid_p.cc @@ -91,7 +91,7 @@ FE_PyramidPoly::FE_PyramidPoly( std::vector( FiniteElementData(dpos, ReferenceCells::Pyramid, 1, degree) .dofs_per_cell, - std::vector(1, true))) + ComponentMask(std::vector(1, true)))) { AssertDimension(dim, 3); diff --git a/source/fe/fe_q_base.cc b/source/fe/fe_q_base.cc index 68bf4dda83..4ce2c81ec0 100644 --- a/source/fe/fe_q_base.cc +++ b/source/fe/fe_q_base.cc @@ -422,7 +422,7 @@ FE_Q_Base::FE_Q_Base( poly_space, fe_data, restriction_is_additive_flags, - std::vector(1, std::vector(1, true))) + std::vector(1, ComponentMask(std::vector(1, true)))) , q_degree(dynamic_cast *>( &poly_space) != nullptr ? this->degree - 1 : diff --git a/source/fe/fe_q_hierarchical.cc b/source/fe/fe_q_hierarchical.cc index b73c9c22cd..61bcd21628 100644 --- a/source/fe/fe_q_hierarchical.cc +++ b/source/fe/fe_q_hierarchical.cc @@ -70,7 +70,7 @@ FE_Q_Hierarchical::FE_Q_Hierarchical(const unsigned int degree) std::vector( FiniteElementData(get_dpo_vector(degree), 1, degree) .n_dofs_per_cell(), - std::vector(1, true))) + ComponentMask(std::vector(1, true)))) , face_renumber(face_fe_q_hierarchical_to_hierarchic_numbering(degree)) { TensorProductPolynomials *poly_space_derived_ptr = diff --git a/source/fe/fe_rannacher_turek.cc b/source/fe/fe_rannacher_turek.cc index cab89759c0..02c7324180 100644 --- a/source/fe/fe_rannacher_turek.cc +++ b/source/fe/fe_rannacher_turek.cc @@ -32,13 +32,14 @@ template FE_RannacherTurek::FE_RannacherTurek( const unsigned int order, const unsigned int n_face_support_points) - : FE_Poly(PolynomialsRannacherTurek(), - FiniteElementData(this->get_dpo_vector(), - 1, - 2, - FiniteElementData::L2), - std::vector(4, false), // restriction not implemented - std::vector(4, std::vector(1, true))) + : FE_Poly( + PolynomialsRannacherTurek(), + FiniteElementData(this->get_dpo_vector(), + 1, + 2, + FiniteElementData::L2), + std::vector(4, false), // restriction not implemented + std::vector(4, ComponentMask(std::vector(1, true)))) , order(order) , n_face_support_points(n_face_support_points) { diff --git a/source/fe/fe_raviart_thomas.cc b/source/fe/fe_raviart_thomas.cc index 442438fb59..bd4024b970 100644 --- a/source/fe/fe_raviart_thomas.cc +++ b/source/fe/fe_raviart_thomas.cc @@ -54,7 +54,7 @@ FE_RaviartThomas::FE_RaviartThomas(const unsigned int deg) true), std::vector( PolynomialsRaviartThomas::n_polynomials(deg + 1, deg), - std::vector(dim, true))) + ComponentMask(std::vector(dim, true)))) { Assert(dim >= 2, ExcImpossibleInDim(dim)); const unsigned int n_dofs = this->n_dofs_per_cell(); diff --git a/source/fe/fe_raviart_thomas_nodal.cc b/source/fe/fe_raviart_thomas_nodal.cc index e59a7f6f38..dac93ffd93 100644 --- a/source/fe/fe_raviart_thomas_nodal.cc +++ b/source/fe/fe_raviart_thomas_nodal.cc @@ -76,7 +76,7 @@ FE_RaviartThomasNodal::FE_RaviartThomasNodal(const unsigned int degree) std::vector(1, false), std::vector( PolynomialsRaviartThomas::n_polynomials(degree + 1, degree), - std::vector(dim, true))) + ComponentMask(std::vector(dim, true)))) { Assert(dim >= 2, ExcImpossibleInDim(dim)); diff --git a/source/fe/fe_rt_bubbles.cc b/source/fe/fe_rt_bubbles.cc index afda9e2c87..e2fdaad578 100644 --- a/source/fe/fe_rt_bubbles.cc +++ b/source/fe/fe_rt_bubbles.cc @@ -48,7 +48,7 @@ FE_RT_Bubbles::FE_RT_Bubbles(const unsigned int deg) FiniteElementData::Hdiv), get_ria_vector(deg), std::vector(PolynomialsRT_Bubbles::n_polynomials(deg), - std::vector(dim, true))) + ComponentMask(std::vector(dim, true)))) { Assert(dim >= 2, ExcImpossibleInDim(dim)); Assert( diff --git a/source/fe/fe_simplex_p.cc b/source/fe/fe_simplex_p.cc index a742b0a603..b75e35be45 100644 --- a/source/fe/fe_simplex_p.cc +++ b/source/fe/fe_simplex_p.cc @@ -284,7 +284,7 @@ FE_SimplexPoly::FE_SimplexPoly( fe_data, std::vector(fe_data.dofs_per_cell), std::vector(fe_data.dofs_per_cell, - std::vector(1, true))) + ComponentMask(std::vector(1, true)))) { this->unit_support_points = unit_support_points; this->unit_face_support_points = unit_face_support_points; diff --git a/source/fe/fe_wedge_p.cc b/source/fe/fe_wedge_p.cc index 1450abb5ee..905ce1932d 100644 --- a/source/fe/fe_wedge_p.cc +++ b/source/fe/fe_wedge_p.cc @@ -101,7 +101,7 @@ FE_WedgePoly::FE_WedgePoly( std::vector( FiniteElementData(dpos, ReferenceCells::Wedge, 1, degree) .dofs_per_cell, - std::vector(1, true))) + ComponentMask(std::vector(1, true)))) { AssertDimension(dim, 3); diff --git a/source/multigrid/mg_tools.cc b/source/multigrid/mg_tools.cc index 011a9cb9bb..b3915516cc 100644 --- a/source/multigrid/mg_tools.cc +++ b/source/multigrid/mg_tools.cc @@ -1217,7 +1217,7 @@ namespace MGTools std::vector tmp(n_blocks, false); tmp[i] = true; - block_select[i] = tmp; + block_select[i] = BlockMask(tmp); tasks += Threads::new_task( fun_ptr, l, dof_handler, block_select[i], dofs_in_block[i]); diff --git a/source/numerics/point_value_history.cc b/source/numerics/point_value_history.cc index cbb5f92005..54ad4dfc4e 100644 --- a/source/numerics/point_value_history.cc +++ b/source/numerics/point_value_history.cc @@ -504,7 +504,7 @@ void PointValueHistory::add_field_name(const std::string &vector_name, const unsigned int n_components) { - std::vector temp_mask(n_components, true); + ComponentMask temp_mask(std::vector(n_components, true)); add_field_name(vector_name, temp_mask); }