From 0e12f6f87a0b84fadd8df629f55da42a8494ce8f Mon Sep 17 00:00:00 2001 From: Daniel Arndt Date: Wed, 9 May 2018 16:58:09 +0200 Subject: [PATCH] Make sure to use override where appropriate --- bundled/muparser_v2_2_4/include/muParser.h | 10 +- .../muparser_v2_2_4/include/muParserBase.h | 6 +- bundled/muparser_v2_2_4/include/muParserInt.h | 8 +- examples/step-12/step-12.cc | 2 +- examples/step-13/step-13.cc | 22 +- examples/step-14/step-14.cc | 42 ++-- examples/step-15/step-15.cc | 2 +- examples/step-16/step-16.cc | 2 +- examples/step-17/step-17.cc | 4 +- examples/step-18/step-18.cc | 8 +- examples/step-20/step-20.cc | 8 +- examples/step-21/step-21.cc | 12 +- examples/step-22/step-22.cc | 8 +- examples/step-23/step-23.cc | 10 +- examples/step-24/step-24.cc | 2 +- examples/step-25/step-25.cc | 4 +- examples/step-26/step-26.cc | 4 +- examples/step-27/step-27.cc | 2 +- examples/step-29/step-29.cc | 6 +- examples/step-30/step-30.cc | 4 +- examples/step-31/step-31.cc | 8 +- examples/step-32/step-32.cc | 12 +- examples/step-33/step-33.cc | 8 +- examples/step-35/step-35.cc | 8 +- examples/step-37/step-37.cc | 10 +- examples/step-38/step-38.cc | 6 +- examples/step-39/step-39.cc | 24 +- examples/step-4/step-4.cc | 6 +- examples/step-41/step-41.cc | 6 +- examples/step-42/step-42.cc | 16 +- examples/step-43/step-43.cc | 12 +- examples/step-45/step-45.cc | 8 +- examples/step-46/step-46.cc | 8 +- examples/step-47/step-47.cc | 12 +- examples/step-48/step-48.cc | 2 +- examples/step-50/step-50.cc | 4 +- examples/step-51/step-51.cc | 10 +- examples/step-55/step-55.cc | 4 +- examples/step-56/step-56.cc | 6 +- examples/step-57/step-57.cc | 4 +- examples/step-7/step-7.cc | 6 +- examples/step-9/step-9.cc | 12 +- include/deal.II/algorithms/newton.h | 4 +- include/deal.II/algorithms/operator.h | 4 +- .../deal.II/algorithms/theta_timestepping.h | 4 +- include/deal.II/base/aligned_vector.h | 8 +- .../deal.II/base/auto_derivative_function.h | 10 +- include/deal.II/base/data_out_base.h | 6 +- include/deal.II/base/exceptions.h | 18 +- include/deal.II/base/flow_function.h | 46 ++-- include/deal.II/base/function.h | 36 +-- include/deal.II/base/function_bessel.h | 8 +- include/deal.II/base/function_cspline.h | 10 +- include/deal.II/base/function_derivative.h | 6 +- include/deal.II/base/function_lib.h | 230 +++++++++--------- include/deal.II/base/function_parser.h | 6 +- include/deal.II/base/function_spherical.h | 6 +- include/deal.II/base/logstream.h | 2 +- include/deal.II/base/parameter_acceptor.h | 6 +- include/deal.II/base/parameter_handler.h | 2 +- include/deal.II/base/parsed_function.h | 6 +- include/deal.II/base/partitioner.h | 4 +- include/deal.II/base/patterns.h | 74 +++--- include/deal.II/base/quadrature.h | 2 +- include/deal.II/base/quadrature_point_data.h | 2 +- include/deal.II/base/table.h | 2 +- include/deal.II/base/tensor_function.h | 12 +- include/deal.II/base/thread_management.h | 2 +- include/deal.II/base/time_stepping.h | 24 +- include/deal.II/base/work_stream.h | 6 +- include/deal.II/distributed/shared_tria.h | 10 +- include/deal.II/distributed/tria.h | 32 +-- include/deal.II/distributed/tria_base.h | 12 +- include/deal.II/dofs/dof_handler.h | 2 +- include/deal.II/dofs/dof_handler_policy.h | 24 +- include/deal.II/fe/fe.h | 2 +- include/deal.II/fe/fe_abf.h | 10 +- include/deal.II/fe/fe_bdm.h | 6 +- include/deal.II/fe/fe_bernstein.h | 24 +- include/deal.II/fe/fe_dg_vector.h | 14 +- include/deal.II/fe/fe_dgp.h | 24 +- include/deal.II/fe/fe_dgp_monomial.h | 24 +- include/deal.II/fe/fe_dgp_nonparametric.h | 44 ++-- include/deal.II/fe/fe_dgq.h | 48 ++-- include/deal.II/fe/fe_enriched.h | 40 +-- include/deal.II/fe/fe_face.h | 78 +++--- include/deal.II/fe/fe_nedelec.h | 30 +-- include/deal.II/fe/fe_nedelec_sz.h | 26 +- include/deal.II/fe/fe_p1nc.h | 20 +- include/deal.II/fe/fe_poly.h | 30 +-- include/deal.II/fe/fe_poly_face.h | 14 +- include/deal.II/fe/fe_poly_tensor.h | 22 +- include/deal.II/fe/fe_q.h | 6 +- include/deal.II/fe/fe_q_base.h | 26 +- include/deal.II/fe/fe_q_bubbles.h | 14 +- include/deal.II/fe/fe_q_dg0.h | 12 +- include/deal.II/fe/fe_q_hierarchical.h | 28 +-- include/deal.II/fe/fe_q_iso_q1.h | 8 +- include/deal.II/fe/fe_rannacher_turek.h | 6 +- include/deal.II/fe/fe_raviart_thomas.h | 34 +-- include/deal.II/fe/fe_system.h | 80 +++--- include/deal.II/fe/fe_tools.h | 6 +- include/deal.II/fe/fe_trace.h | 20 +- include/deal.II/fe/fe_values.h | 2 +- include/deal.II/grid/grid_tools_cache.h | 2 +- include/deal.II/grid/manifold.h | 2 +- include/deal.II/grid/persistent_tria.h | 12 +- include/deal.II/grid/tria.h | 4 +- include/deal.II/hp/dof_handler.h | 2 +- include/deal.II/lac/block_matrix_base.h | 2 +- include/deal.II/lac/block_sparse_matrix.h | 2 +- include/deal.II/lac/block_sparsity_pattern.h | 2 +- include/deal.II/lac/block_vector.h | 2 +- include/deal.II/lac/chunk_sparse_matrix.h | 2 +- include/deal.II/lac/chunk_sparsity_pattern.h | 2 +- include/deal.II/lac/exceptions.h | 2 +- include/deal.II/lac/matrix_out.h | 6 +- include/deal.II/lac/petsc_full_matrix.h | 2 +- include/deal.II/lac/petsc_matrix_base.h | 2 +- include/deal.II/lac/petsc_matrix_free.h | 2 +- .../lac/petsc_parallel_block_sparse_matrix.h | 2 +- .../deal.II/lac/petsc_parallel_block_vector.h | 2 +- .../lac/petsc_parallel_sparse_matrix.h | 4 +- include/deal.II/lac/petsc_parallel_vector.h | 4 +- include/deal.II/lac/petsc_solver.h | 26 +- include/deal.II/lac/petsc_sparse_matrix.h | 2 +- include/deal.II/lac/petsc_vector_base.h | 2 +- include/deal.II/lac/pointer_matrix.h | 22 +- include/deal.II/lac/precondition.h | 4 +- include/deal.II/lac/precondition_block.h | 2 +- include/deal.II/lac/precondition_selector.h | 2 +- include/deal.II/lac/read_write_vector.h | 2 +- include/deal.II/lac/scalapack.h | 2 +- include/deal.II/lac/solver_bicgstab.h | 2 +- include/deal.II/lac/solver_cg.h | 2 +- include/deal.II/lac/solver_control.h | 18 +- include/deal.II/lac/solver_minres.h | 2 +- include/deal.II/lac/solver_richardson.h | 2 +- include/deal.II/lac/solver_selector.h | 2 +- include/deal.II/lac/sparse_decomposition.h | 4 +- include/deal.II/lac/sparse_direct.h | 2 +- include/deal.II/lac/sparse_ilu.h | 2 +- include/deal.II/lac/sparse_matrix.h | 2 +- include/deal.II/lac/sparse_matrix_ez.h | 2 +- include/deal.II/lac/sparse_mic.h | 6 +- include/deal.II/lac/sparsity_pattern.h | 2 +- include/deal.II/lac/swappable_vector.h | 2 +- .../lac/trilinos_block_sparse_matrix.h | 2 +- .../trilinos_epetra_communication_pattern.h | 8 +- .../lac/trilinos_parallel_block_vector.h | 2 +- include/deal.II/lac/trilinos_precondition.h | 18 +- include/deal.II/lac/trilinos_sparse_matrix.h | 24 +- .../deal.II/lac/trilinos_sparsity_pattern.h | 2 +- include/deal.II/lac/trilinos_vector.h | 2 +- include/deal.II/lac/vector.h | 2 +- include/deal.II/lac/vector_memory.h | 12 +- include/deal.II/lac/vector_view.h | 6 +- include/deal.II/matrix_free/matrix_free.h | 2 +- include/deal.II/matrix_free/operators.h | 6 +- include/deal.II/meshworker/local_integrator.h | 2 +- include/deal.II/meshworker/vector_selector.h | 6 +- include/deal.II/multigrid/mg_base.h | 8 +- include/deal.II/multigrid/mg_coarse.h | 6 +- include/deal.II/multigrid/mg_matrix.h | 12 +- include/deal.II/multigrid/mg_smoother.h | 12 +- include/deal.II/multigrid/mg_transfer.h | 6 +- include/deal.II/multigrid/mg_transfer_block.h | 12 +- .../deal.II/multigrid/mg_transfer_component.h | 6 +- .../multigrid/mg_transfer_matrix_free.h | 12 +- include/deal.II/numerics/data_out_dof_data.h | 8 +- .../numerics/data_out_dof_data.templates.h | 20 +- include/deal.II/numerics/data_out_stack.h | 6 +- include/deal.II/numerics/data_postprocessor.h | 20 +- .../deal.II/numerics/dof_output_operator.h | 2 +- .../numerics/dof_output_operator.templates.h | 2 +- include/deal.II/numerics/fe_field_function.h | 24 +- include/deal.II/numerics/time_dependent.h | 10 +- include/deal.II/particles/particle_handler.h | 2 +- source/base/logstream.cc | 4 +- source/fe/fe_values.cc | 12 +- source/fe/fe_values.decl.2.inst.in | 2 +- source/lac/trilinos_solver.cc | 10 +- source/matrix_free/task_info.cc | 8 +- 183 files changed, 1077 insertions(+), 1077 deletions(-) diff --git a/bundled/muparser_v2_2_4/include/muParser.h b/bundled/muparser_v2_2_4/include/muParser.h index 39fe137fe7..a1caec4c8b 100644 --- a/bundled/muparser_v2_2_4/include/muParser.h +++ b/bundled/muparser_v2_2_4/include/muParser.h @@ -54,11 +54,11 @@ namespace mu Parser(); - virtual void InitCharSets(); - virtual void InitFun(); - virtual void InitConst(); - virtual void InitOprt(); - virtual void OnDetectVar(string_type *pExpr, int &nStart, int &nEnd); + virtual void InitCharSets() override; + virtual void InitFun() override; + virtual void InitConst() override; + virtual void InitOprt() override; + virtual void OnDetectVar(string_type *pExpr, int &nStart, int &nEnd) override; value_type Diff(value_type *a_Var, value_type a_fPos, diff --git a/bundled/muparser_v2_2_4/include/muParserBase.h b/bundled/muparser_v2_2_4/include/muParserBase.h index 685f59fbd9..871724be84 100644 --- a/bundled/muparser_v2_2_4/include/muParserBase.h +++ b/bundled/muparser_v2_2_4/include/muParserBase.h @@ -209,17 +209,17 @@ private: protected: - virtual char_type do_decimal_point() const + virtual char_type do_decimal_point() const override { return m_cDecPoint; } - virtual char_type do_thousands_sep() const + virtual char_type do_thousands_sep() const override { return m_cThousandsSep; } - virtual std::string do_grouping() const + virtual std::string do_grouping() const override { // fix for issue 4: https://code.google.com/p/muparser/issues/detail?id=4 // courtesy of Jens Bartsch diff --git a/bundled/muparser_v2_2_4/include/muParserInt.h b/bundled/muparser_v2_2_4/include/muParserInt.h index 136de33971..61e7740007 100644 --- a/bundled/muparser_v2_2_4/include/muParserInt.h +++ b/bundled/muparser_v2_2_4/include/muParserInt.h @@ -128,10 +128,10 @@ private: public: ParserInt(); - virtual void InitFun(); - virtual void InitOprt(); - virtual void InitConst(); - virtual void InitCharSets(); + virtual void InitFun() override; + virtual void InitOprt() override; + virtual void InitConst() override; + virtual void InitCharSets() override; }; } // namespace mu diff --git a/examples/step-12/step-12.cc b/examples/step-12/step-12.cc index 85a08cfd34..9b96dba32a 100644 --- a/examples/step-12/step-12.cc +++ b/examples/step-12/step-12.cc @@ -91,7 +91,7 @@ namespace Step12 BoundaryValues () {} virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component=0) const; + const unsigned int component=0) const override; }; // Given the flow direction, the inflow boundary of the unit square diff --git a/examples/step-13/step-13.cc b/examples/step-13/step-13.cc index 91a982ff8f..5cee0efad7 100644 --- a/examples/step-13/step-13.cc +++ b/examples/step-13/step-13.cc @@ -181,7 +181,7 @@ namespace Step13 TableHandler &results_table); virtual void operator () (const DoFHandler &dof_handler, - const Vector &solution) const; + const Vector &solution) const override; DeclException1 (ExcEvaluationPointNotFound, Point, @@ -374,7 +374,7 @@ namespace Step13 const DataOutBase::OutputFormat output_format); virtual void operator () (const DoFHandler &dof_handler, - const Vector &solution) const; + const Vector &solution) const override; private: const std::string output_name_base; const DataOutBase::OutputFormat output_format; @@ -585,19 +585,19 @@ namespace Step13 const Quadrature &quadrature, const Function &boundary_values); virtual - ~Solver (); + ~Solver () override; virtual void - solve_problem (); + solve_problem () override; virtual void - postprocess (const Evaluation::EvaluationBase &postprocessor) const; + postprocess (const Evaluation::EvaluationBase &postprocessor) const override; virtual unsigned int - n_dofs () const; + n_dofs () const override; // In the protected section of this class, we first have a number of // member variables, of which the use should be clear from the previous @@ -1103,7 +1103,7 @@ namespace Step13 const Function &boundary_values); protected: const SmartPointer > rhs_function; - virtual void assemble_rhs (Vector &rhs) const; + virtual void assemble_rhs (Vector &rhs) const override; }; @@ -1196,7 +1196,7 @@ namespace Step13 const Function &rhs_function, const Function &boundary_values); - virtual void refine_grid (); + virtual void refine_grid () override; }; @@ -1245,7 +1245,7 @@ namespace Step13 const Function &rhs_function, const Function &boundary_values); - virtual void refine_grid (); + virtual void refine_grid () override; }; @@ -1313,7 +1313,7 @@ namespace Step13 Solution () : Function () {} virtual double value (const Point &p, - const unsigned int component) const; + const unsigned int component) const override; }; @@ -1338,7 +1338,7 @@ namespace Step13 RightHandSide () : Function () {} virtual double value (const Point &p, - const unsigned int component) const; + const unsigned int component) const override; }; diff --git a/examples/step-14/step-14.cc b/examples/step-14/step-14.cc index 22d440515b..5cf552f390 100644 --- a/examples/step-14/step-14.cc +++ b/examples/step-14/step-14.cc @@ -109,7 +109,7 @@ namespace Step14 PointValueEvaluation (const Point &evaluation_point); virtual void operator () (const DoFHandler &dof_handler, - const Vector &solution) const; + const Vector &solution) const override; DeclException1 (ExcEvaluationPointNotFound, Point, @@ -324,7 +324,7 @@ namespace Step14 GridOutput (const std::string &output_name_base); virtual void operator () (const DoFHandler &dof_handler, - const Vector &solution) const; + const Vector &solution) const override; private: const std::string output_name_base; }; @@ -426,19 +426,19 @@ namespace Step14 const Quadrature &face_quadrature, const Function &boundary_values); virtual - ~Solver (); + ~Solver () override; virtual void - solve_problem (); + solve_problem () override; virtual void - postprocess (const Evaluation::EvaluationBase &postprocessor) const; + postprocess (const Evaluation::EvaluationBase &postprocessor) const override; virtual unsigned int - n_dofs () const; + n_dofs () const override; protected: const SmartPointer > fe; @@ -763,11 +763,11 @@ namespace Step14 const Function &boundary_values); virtual - void output_solution () const; + void output_solution () const override; protected: const SmartPointer > rhs_function; - virtual void assemble_rhs (Vector &rhs) const; + virtual void assemble_rhs (Vector &rhs) const override; }; @@ -862,7 +862,7 @@ namespace Step14 const Function &rhs_function, const Function &boundary_values); - virtual void refine_grid (); + virtual void refine_grid () override; }; @@ -904,7 +904,7 @@ namespace Step14 const Function &rhs_function, const Function &boundary_values); - virtual void refine_grid (); + virtual void refine_grid () override; }; @@ -968,7 +968,7 @@ namespace Step14 const Function &boundary_values, const Function &weighting_function); - virtual void refine_grid (); + virtual void refine_grid () override; private: const SmartPointer > weighting_function; @@ -1133,14 +1133,14 @@ namespace Step14 struct SetUp : public SetUpBase { virtual - const Function &get_boundary_values () const; + const Function &get_boundary_values () const override; virtual - const Function &get_right_hand_side () const; + const Function &get_right_hand_side () const override; virtual - void create_coarse_grid (Triangulation &coarse_grid) const; + void create_coarse_grid (Triangulation &coarse_grid) const override; private: static const typename Traits::BoundaryValues boundary_values; @@ -1514,7 +1514,7 @@ namespace Step14 virtual void assemble_rhs (const DoFHandler &dof_handler, - Vector &rhs) const; + Vector &rhs) const override; DeclException1 (ExcEvaluationPointNotFound, Point, @@ -1746,7 +1746,7 @@ namespace Step14 protected: const SmartPointer > dual_functional; - virtual void assemble_rhs (Vector &rhs) const; + virtual void assemble_rhs (Vector &rhs) const override; static const Functions::ZeroFunction boundary_values; }; @@ -1806,21 +1806,21 @@ namespace Step14 virtual void - solve_problem (); + solve_problem () override; virtual void - postprocess (const Evaluation::EvaluationBase &postprocessor) const; + postprocess (const Evaluation::EvaluationBase &postprocessor) const override; virtual unsigned int - n_dofs () const; + n_dofs () const override; - virtual void refine_grid (); + virtual void refine_grid () override; virtual void - output_solution () const; + output_solution () const override; private: // In the private section, we have two functions that are used to call diff --git a/examples/step-15/step-15.cc b/examples/step-15/step-15.cc index cb0fdb98b2..ff55ef096d 100644 --- a/examples/step-15/step-15.cc +++ b/examples/step-15/step-15.cc @@ -143,7 +143,7 @@ namespace Step15 BoundaryValues () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; diff --git a/examples/step-16/step-16.cc b/examples/step-16/step-16.cc index e435ef1124..c27867f6c2 100644 --- a/examples/step-16/step-16.cc +++ b/examples/step-16/step-16.cc @@ -107,7 +107,7 @@ namespace Step16 { public: LaplaceIntegrator(); - virtual void cell(MeshWorker::DoFInfo &dinfo, MeshWorker::IntegrationInfo &info) const; + virtual void cell(MeshWorker::DoFInfo &dinfo, MeshWorker::IntegrationInfo &info) const override; }; diff --git a/examples/step-17/step-17.cc b/examples/step-17/step-17.cc index 5a5a2ecac2..50f5d23769 100644 --- a/examples/step-17/step-17.cc +++ b/examples/step-17/step-17.cc @@ -189,10 +189,10 @@ namespace Step17 RightHandSide (); virtual void vector_value (const Point &p, - Vector &values) const; + Vector &values) const override; virtual void vector_value_list (const std::vector > &points, - std::vector > &value_list) const; + std::vector > &value_list) const override; }; diff --git a/examples/step-18/step-18.cc b/examples/step-18/step-18.cc index 6c097f45f3..d95bdaa866 100644 --- a/examples/step-18/step-18.cc +++ b/examples/step-18/step-18.cc @@ -565,12 +565,12 @@ namespace Step18 virtual void vector_value (const Point &p, - Vector &values) const; + Vector &values) const override; virtual void vector_value_list (const std::vector > &points, - std::vector > &value_list) const; + std::vector > &value_list) const override; }; @@ -653,12 +653,12 @@ namespace Step18 virtual void vector_value (const Point &p, - Vector &values) const; + Vector &values) const override; virtual void vector_value_list (const std::vector > &points, - std::vector > &value_list) const; + std::vector > &value_list) const override; private: const double velocity; diff --git a/examples/step-20/step-20.cc b/examples/step-20/step-20.cc index f27bd453fd..85dc4aa5a2 100644 --- a/examples/step-20/step-20.cc +++ b/examples/step-20/step-20.cc @@ -128,7 +128,7 @@ namespace Step20 RightHandSide () : Function(1) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -140,7 +140,7 @@ namespace Step20 PressureBoundaryValues () : Function(1) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -151,7 +151,7 @@ namespace Step20 ExactSolution () : Function(dim+1) {} virtual void vector_value (const Point &p, - Vector &value) const; + Vector &value) const override; }; @@ -229,7 +229,7 @@ namespace Step20 KInverse () : TensorFunction<2,dim>() {} virtual void value_list (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; }; diff --git a/examples/step-21/step-21.cc b/examples/step-21/step-21.cc index 9c3d46b2ab..f68fbc7d53 100644 --- a/examples/step-21/step-21.cc +++ b/examples/step-21/step-21.cc @@ -143,7 +143,7 @@ namespace Step21 PressureRightHandSide () : Function(1) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -168,7 +168,7 @@ namespace Step21 PressureBoundaryValues () : Function(1) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -195,7 +195,7 @@ namespace Step21 SaturationBoundaryValues () : Function(1) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -233,10 +233,10 @@ namespace Step21 InitialValues () : Function(dim+2) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value (const Point &p, - Vector &value) const; + Vector &value) const override; }; @@ -362,7 +362,7 @@ namespace Step21 {} virtual void value_list (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; private: static std::vector > centers; diff --git a/examples/step-22/step-22.cc b/examples/step-22/step-22.cc index 53efefffab..62e9d7c97f 100644 --- a/examples/step-22/step-22.cc +++ b/examples/step-22/step-22.cc @@ -183,10 +183,10 @@ namespace Step22 BoundaryValues () : Function(dim+1) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value (const Point &p, - Vector &value) const; + Vector &value) const override; }; @@ -224,10 +224,10 @@ namespace Step22 RightHandSide () : Function(dim+1) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value (const Point &p, - Vector &value) const; + Vector &value) const override; }; diff --git a/examples/step-23/step-23.cc b/examples/step-23/step-23.cc index 8362d54c94..dd2b38865f 100644 --- a/examples/step-23/step-23.cc +++ b/examples/step-23/step-23.cc @@ -166,7 +166,7 @@ namespace Step23 InitialValuesU () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -177,7 +177,7 @@ namespace Step23 InitialValuesV () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -213,7 +213,7 @@ namespace Step23 RightHandSide () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -238,7 +238,7 @@ namespace Step23 BoundaryValuesU () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -251,7 +251,7 @@ namespace Step23 BoundaryValuesV () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; diff --git a/examples/step-24/step-24.cc b/examples/step-24/step-24.cc index 497cd74b25..eb23ece696 100644 --- a/examples/step-24/step-24.cc +++ b/examples/step-24/step-24.cc @@ -145,7 +145,7 @@ namespace Step24 {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; private: struct Source diff --git a/examples/step-25/step-25.cc b/examples/step-25/step-25.cc index 1f9462df7a..4416a31b52 100644 --- a/examples/step-25/step-25.cc +++ b/examples/step-25/step-25.cc @@ -156,7 +156,7 @@ namespace Step25 ExactSolution (const unsigned int n_components = 1, const double time = 0.) : Function(n_components, time) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; template @@ -227,7 +227,7 @@ namespace Step25 {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; template diff --git a/examples/step-26/step-26.cc b/examples/step-26/step-26.cc index c5dbd996e0..cd5a7024e7 100644 --- a/examples/step-26/step-26.cc +++ b/examples/step-26/step-26.cc @@ -133,7 +133,7 @@ namespace Step26 {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; private: const double period; @@ -177,7 +177,7 @@ namespace Step26 { public: virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; diff --git a/examples/step-27/step-27.cc b/examples/step-27/step-27.cc index 3dd1d5f968..ddd6e0a610 100644 --- a/examples/step-27/step-27.cc +++ b/examples/step-27/step-27.cc @@ -139,7 +139,7 @@ namespace Step27 RightHandSide () : Function () {} virtual double value (const Point &p, - const unsigned int component) const; + const unsigned int component) const override; }; diff --git a/examples/step-29/step-29.cc b/examples/step-29/step-29.cc index 9cc11cda53..7307bda3d8 100644 --- a/examples/step-29/step-29.cc +++ b/examples/step-29/step-29.cc @@ -102,10 +102,10 @@ namespace Step29 DirichletBoundaryValues() : Function (2) {}; virtual void vector_value (const Point &p, - Vector &values) const; + Vector &values) const override; virtual void vector_value_list (const std::vector > &points, - std::vector > &value_list) const; + std::vector > &value_list) const override; }; @@ -302,7 +302,7 @@ namespace Step29 void evaluate_vector_field (const DataPostprocessorInputs::Vector &inputs, - std::vector > &computed_quantities) const; + std::vector > &computed_quantities) const override; }; // In the constructor, we need to call the constructor of the base class diff --git a/examples/step-30/step-30.cc b/examples/step-30/step-30.cc index b82663e6c9..25fc3b1e40 100644 --- a/examples/step-30/step-30.cc +++ b/examples/step-30/step-30.cc @@ -62,7 +62,7 @@ namespace Step30 public: virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component=0) const; + const unsigned int component=0) const override; }; @@ -72,7 +72,7 @@ namespace Step30 public: virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component=0) const; + const unsigned int component=0) const override; }; diff --git a/examples/step-31/step-31.cc b/examples/step-31/step-31.cc index 0097099d8a..2b0965bb01 100644 --- a/examples/step-31/step-31.cc +++ b/examples/step-31/step-31.cc @@ -133,10 +133,10 @@ namespace Step31 TemperatureInitialValues () : Function(1) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value (const Point &p, - Vector &value) const; + Vector &value) const override; }; @@ -166,10 +166,10 @@ namespace Step31 TemperatureRightHandSide () : Function(1) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value (const Point &p, - Vector &value) const; + Vector &value) const override; }; diff --git a/examples/step-32/step-32.cc b/examples/step-32/step-32.cc index 9018bb525c..1c84be0780 100644 --- a/examples/step-32/step-32.cc +++ b/examples/step-32/step-32.cc @@ -154,10 +154,10 @@ namespace Step32 TemperatureInitialValues () : Function(1) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value (const Point &p, - Vector &value) const; + Vector &value) const override; }; @@ -3155,15 +3155,15 @@ namespace Step32 void evaluate_vector_field (const DataPostprocessorInputs::Vector &inputs, - std::vector > &computed_quantities) const; + std::vector > &computed_quantities) const override; - virtual std::vector get_names () const; + virtual std::vector get_names () const override; virtual std::vector - get_data_component_interpretation () const; + get_data_component_interpretation () const override; - virtual UpdateFlags get_needed_update_flags () const; + virtual UpdateFlags get_needed_update_flags () const override; private: const unsigned int partition; diff --git a/examples/step-33/step-33.cc b/examples/step-33/step-33.cc index d608e94768..59499ec6ba 100644 --- a/examples/step-33/step-33.cc +++ b/examples/step-33/step-33.cc @@ -539,15 +539,15 @@ namespace Step33 void evaluate_vector_field (const DataPostprocessorInputs::Vector &inputs, - std::vector > &computed_quantities) const; + std::vector > &computed_quantities) const override; - virtual std::vector get_names () const; + virtual std::vector get_names () const override; virtual std::vector - get_data_component_interpretation () const; + get_data_component_interpretation () const override; - virtual UpdateFlags get_needed_update_flags () const; + virtual UpdateFlags get_needed_update_flags () const override; private: const bool do_schlieren_plot; diff --git a/examples/step-35/step-35.cc b/examples/step-35/step-35.cc index 755bbcb377..731608c0c7 100644 --- a/examples/step-35/step-35.cc +++ b/examples/step-35/step-35.cc @@ -312,11 +312,11 @@ namespace Step35 Velocity (const double initial_time = 0.0); virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void value_list (const std::vector< Point > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -363,11 +363,11 @@ namespace Step35 Pressure (const double initial_time = 0.0); virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void value_list (const std::vector< Point > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; template diff --git a/examples/step-37/step-37.cc b/examples/step-37/step-37.cc index 421e29a2ae..728dcd32c2 100644 --- a/examples/step-37/step-37.cc +++ b/examples/step-37/step-37.cc @@ -93,7 +93,7 @@ namespace Step37 Coefficient () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; template number value (const Point &p, @@ -101,7 +101,7 @@ namespace Step37 virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -246,15 +246,15 @@ namespace Step37 LaplaceOperator (); - void clear(); + void clear() override; void evaluate_coefficient(const Coefficient &coefficient_function); - virtual void compute_diagonal(); + virtual void compute_diagonal() override; private: virtual void apply_add(LinearAlgebra::distributed::Vector &dst, - const LinearAlgebra::distributed::Vector &src) const; + const LinearAlgebra::distributed::Vector &src) const override; void local_apply (const MatrixFree &data, LinearAlgebra::distributed::Vector &dst, diff --git a/examples/step-38/step-38.cc b/examples/step-38/step-38.cc index a26305bdd2..0026008ba6 100644 --- a/examples/step-38/step-38.cc +++ b/examples/step-38/step-38.cc @@ -142,10 +142,10 @@ namespace Step38 Solution () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -207,7 +207,7 @@ namespace Step38 RightHandSide () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; template <> diff --git a/examples/step-39/step-39.cc b/examples/step-39/step-39.cc index 81a84479f9..a911f0acb1 100644 --- a/examples/step-39/step-39.cc +++ b/examples/step-39/step-39.cc @@ -96,13 +96,13 @@ namespace Step39 { public: void cell(MeshWorker::DoFInfo &dinfo, - typename MeshWorker::IntegrationInfo &info) const; + typename MeshWorker::IntegrationInfo &info) const override; void boundary(MeshWorker::DoFInfo &dinfo, - typename MeshWorker::IntegrationInfo &info) const; + typename MeshWorker::IntegrationInfo &info) const override; void face(MeshWorker::DoFInfo &dinfo1, MeshWorker::DoFInfo &dinfo2, typename MeshWorker::IntegrationInfo &info1, - typename MeshWorker::IntegrationInfo &info2) const; + typename MeshWorker::IntegrationInfo &info2) const override; }; @@ -158,12 +158,12 @@ namespace Step39 class RHSIntegrator : public MeshWorker::LocalIntegrator { public: - void cell(MeshWorker::DoFInfo &dinfo, typename MeshWorker::IntegrationInfo &info) const; - void boundary(MeshWorker::DoFInfo &dinfo, typename MeshWorker::IntegrationInfo &info) const; + void cell(MeshWorker::DoFInfo &dinfo, typename MeshWorker::IntegrationInfo &info) const override; + void boundary(MeshWorker::DoFInfo &dinfo, typename MeshWorker::IntegrationInfo &info) const override; void face(MeshWorker::DoFInfo &dinfo1, MeshWorker::DoFInfo &dinfo2, typename MeshWorker::IntegrationInfo &info1, - typename MeshWorker::IntegrationInfo &info2) const; + typename MeshWorker::IntegrationInfo &info2) const override; }; @@ -207,12 +207,12 @@ namespace Step39 class Estimator : public MeshWorker::LocalIntegrator { public: - void cell(MeshWorker::DoFInfo &dinfo, typename MeshWorker::IntegrationInfo &info) const; - void boundary(MeshWorker::DoFInfo &dinfo, typename MeshWorker::IntegrationInfo &info) const; + void cell(MeshWorker::DoFInfo &dinfo, typename MeshWorker::IntegrationInfo &info) const override; + void boundary(MeshWorker::DoFInfo &dinfo, typename MeshWorker::IntegrationInfo &info) const override; void face(MeshWorker::DoFInfo &dinfo1, MeshWorker::DoFInfo &dinfo2, typename MeshWorker::IntegrationInfo &info1, - typename MeshWorker::IntegrationInfo &info2) const; + typename MeshWorker::IntegrationInfo &info2) const override; }; @@ -303,12 +303,12 @@ namespace Step39 class ErrorIntegrator : public MeshWorker::LocalIntegrator { public: - void cell(MeshWorker::DoFInfo &dinfo, typename MeshWorker::IntegrationInfo &info) const; - void boundary(MeshWorker::DoFInfo &dinfo, typename MeshWorker::IntegrationInfo &info) const; + void cell(MeshWorker::DoFInfo &dinfo, typename MeshWorker::IntegrationInfo &info) const override; + void boundary(MeshWorker::DoFInfo &dinfo, typename MeshWorker::IntegrationInfo &info) const override; void face(MeshWorker::DoFInfo &dinfo1, MeshWorker::DoFInfo &dinfo2, typename MeshWorker::IntegrationInfo &info1, - typename MeshWorker::IntegrationInfo &info2) const; + typename MeshWorker::IntegrationInfo &info2) const override; }; // Here we have the integration on cells. There is currently no good diff --git a/examples/step-4/step-4.cc b/examples/step-4/step-4.cc index 3e758dfabd..542ca23233 100644 --- a/examples/step-4/step-4.cc +++ b/examples/step-4/step-4.cc @@ -137,7 +137,7 @@ public: RightHandSide () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -149,7 +149,7 @@ public: BoundaryValues () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -183,7 +183,7 @@ double RightHandSide::value (const Point &p, for (unsigned int i=0; i() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; template @@ -145,7 +145,7 @@ namespace Step41 BoundaryValues () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; template @@ -169,7 +169,7 @@ namespace Step41 Obstacle () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; template diff --git a/examples/step-42/step-42.cc b/examples/step-42/step-42.cc index c30f6c91e2..dcde515dd2 100644 --- a/examples/step-42/step-42.cc +++ b/examples/step-42/step-42.cc @@ -283,11 +283,11 @@ namespace Step42 virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value (const Point &p, - Vector &values) const; + Vector &values) const override; }; template @@ -323,11 +323,11 @@ namespace Step42 BoundaryValues (); virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value (const Point &p, - Vector &values) const; + Vector &values) const override; }; @@ -375,11 +375,11 @@ namespace Step42 virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value (const Point &p, - Vector &values) const; + Vector &values) const override; private: const double z_surface; @@ -563,11 +563,11 @@ namespace Step42 virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value (const Point &p, - Vector &values) const; + Vector &values) const override; private: const BitmapFile input_obstacle; diff --git a/examples/step-43/step-43.cc b/examples/step-43/step-43.cc index 43785e623c..7de2592398 100644 --- a/examples/step-43/step-43.cc +++ b/examples/step-43/step-43.cc @@ -89,7 +89,7 @@ namespace Step43 PressureRightHandSide () : Function(1) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -110,7 +110,7 @@ namespace Step43 PressureBoundaryValues () : Function(1) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -130,7 +130,7 @@ namespace Step43 SaturationBoundaryValues () : Function(1) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -154,10 +154,10 @@ namespace Step43 SaturationInitialValues () : Function(1) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value (const Point &p, - Vector &value) const; + Vector &value) const override; }; @@ -239,7 +239,7 @@ namespace Step43 {} virtual void value_list (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; private: static std::vector > centers; diff --git a/examples/step-45/step-45.cc b/examples/step-45/step-45.cc index 1b708bde6b..40b760166e 100644 --- a/examples/step-45/step-45.cc +++ b/examples/step-45/step-45.cc @@ -112,10 +112,10 @@ namespace Step45 BoundaryValues () : Function(dim+1) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value (const Point &p, - Vector &value) const; + Vector &value) const override; }; @@ -149,10 +149,10 @@ namespace Step45 RightHandSide () : Function(dim+1) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value (const Point &p, - Vector &value) const; + Vector &value) const override; }; diff --git a/examples/step-46/step-46.cc b/examples/step-46/step-46.cc index a789658a4e..b9ddfe57c8 100644 --- a/examples/step-46/step-46.cc +++ b/examples/step-46/step-46.cc @@ -162,10 +162,10 @@ namespace Step46 StokesBoundaryValues () : Function(dim+1+dim) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value (const Point &p, - Vector &value) const; + Vector &value) const override; }; @@ -210,10 +210,10 @@ namespace Step46 RightHandSide () : Function(dim+1) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value (const Point &p, - Vector &value) const; + Vector &value) const override; }; diff --git a/examples/step-47/step-47.cc b/examples/step-47/step-47.cc index 5e431f88bc..b5b98249fd 100644 --- a/examples/step-47/step-47.cc +++ b/examples/step-47/step-47.cc @@ -121,11 +121,11 @@ namespace Step47 Coefficient () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -907,15 +907,15 @@ namespace Step47 void evaluate_vector_field (const dealii::DataPostprocessorInputs::Vector &inputs, - std::vector > &computed_quantities) const; + std::vector > &computed_quantities) const override; - virtual std::vector get_names () const; + virtual std::vector get_names () const override; virtual std::vector - get_data_component_interpretation () const; + get_data_component_interpretation () const override; - virtual UpdateFlags get_needed_update_flags () const; + virtual UpdateFlags get_needed_update_flags () const override; }; diff --git a/examples/step-48/step-48.cc b/examples/step-48/step-48.cc index 56e6d13d65..1c4a9da66d 100644 --- a/examples/step-48/step-48.cc +++ b/examples/step-48/step-48.cc @@ -250,7 +250,7 @@ namespace Step48 ExactSolution (const unsigned int n_components = 1, const double time = 0.) : Function(n_components, time) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; template diff --git a/examples/step-50/step-50.cc b/examples/step-50/step-50.cc index 5d1b2ca591..48276bfcc1 100644 --- a/examples/step-50/step-50.cc +++ b/examples/step-50/step-50.cc @@ -160,11 +160,11 @@ namespace Step50 Coefficient () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; diff --git a/examples/step-51/step-51.cc b/examples/step-51/step-51.cc index 2352760087..c0657afef5 100644 --- a/examples/step-51/step-51.cc +++ b/examples/step-51/step-51.cc @@ -141,10 +141,10 @@ namespace Step51 Solution () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -201,7 +201,7 @@ namespace Step51 SolutionAndGradient () : Function(dim) {} virtual void vector_value (const Point &p, - Vector &v) const; + Vector &v) const override; }; template @@ -227,7 +227,7 @@ namespace Step51 public: ConvectionVelocity() : TensorFunction<1,dim>() {} - virtual Tensor<1,dim> value (const Point &p) const; + virtual Tensor<1,dim> value (const Point &p) const override; }; @@ -272,7 +272,7 @@ namespace Step51 RightHandSide () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; private: const ConvectionVelocity convection_velocity; diff --git a/examples/step-55/step-55.cc b/examples/step-55/step-55.cc index 364d056f7a..ed2d680a25 100644 --- a/examples/step-55/step-55.cc +++ b/examples/step-55/step-55.cc @@ -201,7 +201,7 @@ namespace Step55 RightHandSide () : Function(dim+1) {} virtual void vector_value (const Point &p, - Vector &value) const; + Vector &value) const override; }; @@ -229,7 +229,7 @@ namespace Step55 ExactSolution () : Function(dim+1) {} virtual void vector_value (const Point &p, - Vector &value) const; + Vector &value) const override; }; template diff --git a/examples/step-56/step-56.cc b/examples/step-56/step-56.cc index 43a49d2d79..7e788853c4 100644 --- a/examples/step-56/step-56.cc +++ b/examples/step-56/step-56.cc @@ -102,9 +102,9 @@ namespace Step56 public: Solution () : Function(dim+1) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; template <> @@ -233,7 +233,7 @@ namespace Step56 RightHandSide () : Function(dim+1) {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; template <> diff --git a/examples/step-57/step-57.cc b/examples/step-57/step-57.cc index 6fc2bf06da..3888166081 100644 --- a/examples/step-57/step-57.cc +++ b/examples/step-57/step-57.cc @@ -153,10 +153,10 @@ namespace Step57 public: BoundaryValues() : Function(dim+1) {} virtual double value(const Point &p, - const unsigned int component) const; + const unsigned int component) const override; virtual void vector_value(const Point &p, - Vector &values) const; + Vector &values) const override; }; template diff --git a/examples/step-7/step-7.cc b/examples/step-7/step-7.cc index e12e35ad4e..a3ee7d5f2c 100644 --- a/examples/step-7/step-7.cc +++ b/examples/step-7/step-7.cc @@ -191,10 +191,10 @@ namespace Step7 Solution () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -290,7 +290,7 @@ namespace Step7 RightHandSide () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; diff --git a/examples/step-9/step-9.cc b/examples/step-9/step-9.cc index 56e999e78e..6f8902c90e 100644 --- a/examples/step-9/step-9.cc +++ b/examples/step-9/step-9.cc @@ -197,10 +197,10 @@ namespace Step9 public: AdvectionField () : TensorFunction<1,dim> () {} - virtual Tensor<1,dim> value (const Point &p) const; + virtual Tensor<1,dim> value (const Point &p) const override; virtual void value_list (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; // In previous examples, we have used assertions that throw exceptions in // several places. However, we have never seen how such exceptions are @@ -290,11 +290,11 @@ namespace Step9 RightHandSide () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; private: static const Point center_point; @@ -361,11 +361,11 @@ namespace Step9 BoundaryValues () : Function() {} virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; diff --git a/include/deal.II/algorithms/newton.h b/include/deal.II/algorithms/newton.h index 3e78da667c..a80a7af97b 100644 --- a/include/deal.II/algorithms/newton.h +++ b/include/deal.II/algorithms/newton.h @@ -94,9 +94,9 @@ namespace Algorithms * are not used by Newton, but will be handed down to the objects * #residual and #inverse_derivative. */ - virtual void operator() (AnyData &out, const AnyData &in); + virtual void operator() (AnyData &out, const AnyData &in) override; - virtual void notify(const Event &); + virtual void notify(const Event &) override; /** * Set the maximal residual reduction allowed without triggering diff --git a/include/deal.II/algorithms/operator.h b/include/deal.II/algorithms/operator.h index 685fea8f30..ae189cc5e2 100644 --- a/include/deal.II/algorithms/operator.h +++ b/include/deal.II/algorithms/operator.h @@ -73,7 +73,7 @@ namespace Algorithms /** * The virtual destructor. */ - virtual ~OperatorBase() = default; + virtual ~OperatorBase() override = default; /** * The actual operation, which is implemented in a derived class. @@ -121,7 +121,7 @@ namespace Algorithms /** * Empty virtual destructor. */ - virtual ~OutputOperator() = default; + virtual ~OutputOperator() override = default; /** * Set the stream @p os to which data is written. If no stream is selected diff --git a/include/deal.II/algorithms/theta_timestepping.h b/include/deal.II/algorithms/theta_timestepping.h index b710651177..56d930cb30 100644 --- a/include/deal.II/algorithms/theta_timestepping.h +++ b/include/deal.II/algorithms/theta_timestepping.h @@ -209,12 +209,12 @@ namespace Algorithms * instance, which contains the initial value when the operator is called. * It contains the final value when the operator returns. */ - virtual void operator() (AnyData &out, const AnyData &in); + virtual void operator() (AnyData &out, const AnyData &in) override; /** * Register an event triggered by an outer iteration. */ - virtual void notify(const Event &); + virtual void notify(const Event &) override; /** * Define an operator which will output the result in each step. Note that diff --git a/include/deal.II/base/aligned_vector.h b/include/deal.II/base/aligned_vector.h index eb9c00955a..779ec812eb 100644 --- a/include/deal.II/base/aligned_vector.h +++ b/include/deal.II/base/aligned_vector.h @@ -376,7 +376,7 @@ namespace internal * the constructor on a subrange given by two integers. */ virtual void apply_to_subrange (const std::size_t begin, - const std::size_t end) const + const std::size_t end) const override { if (end == begin) return; @@ -439,7 +439,7 @@ namespace internal * the constructor on a subrange given by two integers. */ virtual void apply_to_subrange (const std::size_t begin, - const std::size_t end) const + const std::size_t end) const override { if (end == begin) return; @@ -522,7 +522,7 @@ namespace internal * This sets elements on a subrange given by two integers. */ virtual void apply_to_subrange (const std::size_t begin, - const std::size_t end) const + const std::size_t end) const override { // for classes with trivial assignment of zero can use memset. cast // element to (void*) to silence compiler warning for virtual @@ -600,7 +600,7 @@ namespace internal * This initializes elements on a subrange given by two integers. */ virtual void apply_to_subrange (const std::size_t begin, - const std::size_t end) const + const std::size_t end) const override { // for classes with trivial assignment of zero can use memset. cast // element to (void*) to silence compiler warning for virtual diff --git a/include/deal.II/base/auto_derivative_function.h b/include/deal.II/base/auto_derivative_function.h index dde380750c..d19caa6fae 100644 --- a/include/deal.II/base/auto_derivative_function.h +++ b/include/deal.II/base/auto_derivative_function.h @@ -132,7 +132,7 @@ public: /** * Virtual destructor; absolutely necessary in this case. */ - virtual ~AutoDerivativeFunction () = default; + virtual ~AutoDerivativeFunction () override = default; /** * Choose the difference formula. See the enum #DifferenceFormula for @@ -158,7 +158,7 @@ public: * #DifferenceFormula. */ virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Return the gradient of all components of the function at the given point. @@ -167,7 +167,7 @@ public: * #DifferenceFormula. */ virtual void vector_gradient (const Point &p, - std::vector > &gradients) const; + std::vector > &gradients) const override; /** * Set gradients to the gradients of the specified component of the @@ -180,7 +180,7 @@ public: */ virtual void gradient_list (const std::vector > &points, std::vector > &gradients, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Set gradients to the gradients of the function at the @@ -195,7 +195,7 @@ public: * #DifferenceFormula. */ virtual void vector_gradient_list (const std::vector > &points, - std::vector > > &gradients) const; + std::vector > > &gradients) const override; /** * Return a #DifferenceFormula of the order ord at minimum. diff --git a/include/deal.II/base/data_out_base.h b/include/deal.II/base/data_out_base.h index 382992af25..fbbeece8aa 100644 --- a/include/deal.II/base/data_out_base.h +++ b/include/deal.II/base/data_out_base.h @@ -2936,7 +2936,7 @@ protected: * read() function. */ virtual const std::vector > & - get_patches () const; + get_patches () const override; /** * Abstract virtual function through which the names of data sets are @@ -2944,7 +2944,7 @@ protected: * * Return the names of the variables as read the last time we read a file. */ - virtual std::vector get_dataset_names () const; + virtual std::vector get_dataset_names () const override; /** * This functions returns information about how the individual components of @@ -2966,7 +2966,7 @@ protected: */ virtual std::vector > - get_vector_data_ranges () const; + get_vector_data_ranges () const override; private: /** diff --git a/include/deal.II/base/exceptions.h b/include/deal.II/base/exceptions.h index 5c0fd05fad..183e580a54 100644 --- a/include/deal.II/base/exceptions.h +++ b/include/deal.II/base/exceptions.h @@ -62,7 +62,7 @@ public: /** * Destructor. */ - virtual ~ExceptionBase () noexcept; + virtual ~ExceptionBase () noexcept override; /** * Copy operator. This operator is deleted since exception objects @@ -85,7 +85,7 @@ public: /** * Override the standard function that returns the description of the error. */ - virtual const char *what() const noexcept; + virtual const char *what() const noexcept override; /** * Get exception name. @@ -193,7 +193,7 @@ private: public: \ Exception (const std::string &msg = defaulttext) : arg (msg) {} \ virtual ~Exception () noexcept {} \ - virtual void print_info (std::ostream &out) const { \ + virtual void print_info (std::ostream &out) const override { \ out << " " << arg << std::endl; \ } \ private: \ @@ -211,7 +211,7 @@ private: public: \ Exception1 (const type1 a1) : arg1 (a1) {} /*NOLINT*/ \ virtual ~Exception1 () noexcept {} \ - virtual void print_info (std::ostream &out) const { \ + virtual void print_info (std::ostream &out) const override { \ out << " " outsequence << std::endl; \ } \ private: \ @@ -231,7 +231,7 @@ private: Exception2 (const type1 a1, const type2 a2) : /*NOLINT*/ \ arg1 (a1), arg2(a2) {} \ virtual ~Exception2 () noexcept {} \ - virtual void print_info (std::ostream &out) const { \ + virtual void print_info (std::ostream &out) const override { \ out << " " outsequence << std::endl; \ } \ private: \ @@ -252,7 +252,7 @@ private: Exception3 (const type1 a1, const type2 a2, const type3 a3) : /*NOLINT*/ \ arg1 (a1), arg2(a2), arg3(a3) {} \ virtual ~Exception3 () noexcept {} \ - virtual void print_info (std::ostream &out) const { \ + virtual void print_info (std::ostream &out) const override { \ out << " " outsequence << std::endl; \ } \ private: \ @@ -275,7 +275,7 @@ private: const type3 a3, const type4 a4) : /*NOLINT*/ \ arg1 (a1), arg2(a2), arg3(a3), arg4(a4) {} \ virtual ~Exception4 () noexcept {} \ - virtual void print_info (std::ostream &out) const { \ + virtual void print_info (std::ostream &out) const override { \ out << " " outsequence << std::endl; \ } \ private: \ @@ -299,7 +299,7 @@ private: const type4 a4, const type5 a5) : /*NOLINT*/ \ arg1 (a1), arg2(a2), arg3(a3), arg4(a4), arg5(a5) {} \ virtual ~Exception5 () noexcept {} \ - virtual void print_info (std::ostream &out) const { \ + virtual void print_info (std::ostream &out) const override { \ out << " " outsequence << std::endl; \ } \ private: \ @@ -922,7 +922,7 @@ namespace StandardExceptions public: ExcMPI (const int error_code); - virtual void print_info (std::ostream &out) const; + virtual void print_info (std::ostream &out) const override; const int error_code; }; diff --git a/include/deal.II/base/flow_function.h b/include/deal.II/base/flow_function.h index 280e4925ab..56b35324d0 100644 --- a/include/deal.II/base/flow_function.h +++ b/include/deal.II/base/flow_function.h @@ -56,7 +56,7 @@ namespace Functions /** * Virtual destructor. */ - virtual ~FlowFunction() = default; + virtual ~FlowFunction() override = default; /** * Store an adjustment for the pressure function, such that its mean value @@ -70,14 +70,14 @@ namespace Functions * point. */ virtual void vector_values (const std::vector > &points, - std::vector > &values) const = 0; + std::vector > &values) const override = 0; /** * Gradients in a structure more suitable for vector valued functions. The * outer vector is indexed by solution component, the inner by quadrature * point. */ virtual void vector_gradients (const std::vector > &points, - std::vector > > &gradients) const = 0; + std::vector > > &gradients) const override = 0; /** * Force terms in a structure more suitable for vector valued functions. * The outer vector is indexed by solution component, the inner by @@ -89,17 +89,17 @@ namespace Functions virtual void vector_laplacians (const std::vector > &points, std::vector > &values) const = 0; - virtual void vector_value (const Point &points, Vector &value) const; - virtual double value (const Point &points, const unsigned int component) const; + virtual void vector_value (const Point &points, Vector &value) const override; + virtual double value (const Point &points, const unsigned int component) const override; virtual void vector_value_list (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; virtual void vector_gradient_list (const std::vector > &points, - std::vector > > &gradients) const; + std::vector > > &gradients) const override; /** * The force term in the momentum equation. */ virtual void vector_laplacian_list (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; std::size_t memory_consumption () const; @@ -146,14 +146,14 @@ namespace Functions PoisseuilleFlow (const double r, const double Re); - virtual ~PoisseuilleFlow() = default; + virtual ~PoisseuilleFlow() override = default; virtual void vector_values (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; virtual void vector_gradients (const std::vector > &points, - std::vector > > &gradients) const; + std::vector > > &gradients) const override; virtual void vector_laplacians (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; private: const double radius; @@ -189,14 +189,14 @@ namespace Functions */ void set_parameters (const double viscosity, const double reaction); - virtual ~StokesCosine() = default; + virtual ~StokesCosine() override = default; virtual void vector_values (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; virtual void vector_gradients (const std::vector > &points, - std::vector > > &gradients) const; + std::vector > > &gradients) const override; virtual void vector_laplacians (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; private: /// The viscosity @@ -230,11 +230,11 @@ namespace Functions StokesLSingularity(); virtual void vector_values (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; virtual void vector_gradients (const std::vector > &points, - std::vector > > &gradients) const; + std::vector > > &gradients) const override; virtual void vector_laplacians (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; private: /// The auxiliary function Psi. double Psi(double phi) const; @@ -279,14 +279,14 @@ namespace Functions */ Kovasznay (const double Re, bool Stokes = false); - virtual ~Kovasznay() = default; + virtual ~Kovasznay() override = default; virtual void vector_values (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; virtual void vector_gradients (const std::vector > &points, - std::vector > > &gradients) const; + std::vector > > &gradients) const override; virtual void vector_laplacians (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; /// The value of lambda. double lambda () const; diff --git a/include/deal.II/base/function.h b/include/deal.II/base/function.h index 1cb716c0ea..2e5b5809d1 100644 --- a/include/deal.II/base/function.h +++ b/include/deal.II/base/function.h @@ -182,7 +182,7 @@ public: * Nonetheless, since derived classes want to call the destructor of a base * class, this destructor is implemented (despite it being pure virtual). */ - virtual ~Function () = 0; + virtual ~Function () override = 0; /** * Assignment operator. This is here only so that you can have objects of @@ -397,30 +397,30 @@ namespace Functions ConstantFunction (const RangeNumberType *begin_ptr, const unsigned int n_components); virtual RangeNumberType value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value (const Point &p, - Vector &return_value) const; + Vector &return_value) const override; virtual void value_list (const std::vector > &points, std::vector &return_values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value_list (const std::vector > &points, - std::vector > &return_values) const; + std::vector > &return_values) const override; virtual Tensor<1,dim, RangeNumberType> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_gradient (const Point &p, - std::vector > &gradients) const; + std::vector > &gradients) const override; virtual void gradient_list (const std::vector > &points, std::vector > &gradients, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_gradient_list (const std::vector > &points, - std::vector > > &gradients) const; + std::vector > > &gradients) const override; std::size_t memory_consumption () const; @@ -540,7 +540,7 @@ public: * Return the value of the function at the given point for all components. */ virtual void vector_value (const Point &p, - Vector &return_value) const; + Vector &return_value) const override; /** * Set values to the point values of the function at the @@ -549,7 +549,7 @@ public: * array. */ virtual void vector_value_list (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; /** * Return an estimate for the memory consumption, in bytes, of this object. @@ -662,7 +662,7 @@ public: * the function given to the constructor produces for this point. */ virtual RangeNumberType value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; private: /** @@ -731,7 +731,7 @@ public: * the function given to the constructor produces for this point. */ virtual RangeNumberType value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Return all components of a vector-valued function at a given point. @@ -739,7 +739,7 @@ public: * values shall have the right size beforehand, i.e. #n_components. */ virtual void vector_value (const Point &p, - Vector &values) const; + Vector &values) const override; private: /** @@ -818,13 +818,13 @@ public: * This destructor is defined as virtual so as to coincide with all other * aspects of class. */ - virtual ~VectorFunctionFromTensorFunction() = default; + virtual ~VectorFunctionFromTensorFunction() override = default; /** * Return a single component of a vector-valued function at a given point. */ virtual RangeNumberType value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Return all components of a vector-valued function at a given point. @@ -832,7 +832,7 @@ public: * values shall have the right size beforehand, i.e. #n_components. */ virtual void vector_value (const Point &p, - Vector &values) const; + Vector &values) const override; /** * Return all components of a vector-valued function at a list of points. @@ -842,7 +842,7 @@ public: * function */ virtual void vector_value_list (const std::vector > &points, - std::vector > &value_list) const; + std::vector > &value_list) const override; private: /** diff --git a/include/deal.II/base/function_bessel.h b/include/deal.II/base/function_bessel.h index 7d09a69a52..354cdaf757 100644 --- a/include/deal.II/base/function_bessel.h +++ b/include/deal.II/base/function_bessel.h @@ -38,15 +38,15 @@ namespace Functions Bessel1(const unsigned int order, const double wave_number, const Point center = Point()); - virtual double value (const Point &points, const unsigned int component) const; + virtual double value (const Point &points, const unsigned int component) const override; virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void gradient_list (const std::vector > &points, std::vector > &gradients, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; private: unsigned int order; double wave_number; diff --git a/include/deal.II/base/function_cspline.h b/include/deal.II/base/function_cspline.h index 5d8c041e7d..53200feb1c 100644 --- a/include/deal.II/base/function_cspline.h +++ b/include/deal.II/base/function_cspline.h @@ -80,19 +80,19 @@ namespace Functions /** * Virtual destructor. */ - virtual ~CSpline(); + virtual ~CSpline() override; virtual double value (const Point &point, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual SymmetricTensor<2,dim> hessian (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual double laplacian(const Point< dim > &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; std::size_t memory_consumption () const; diff --git a/include/deal.II/base/function_derivative.h b/include/deal.II/base/function_derivative.h index e2217c75a0..6f76cadb27 100644 --- a/include/deal.II/base/function_derivative.h +++ b/include/deal.II/base/function_derivative.h @@ -85,14 +85,14 @@ public: void set_h (const double h); virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value(const Point &p, - Vector &value) const; + Vector &value) const override; virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Return an estimate for the memory consumption, in bytes, of this object. diff --git a/include/deal.II/base/function_lib.h b/include/deal.II/base/function_lib.h index 3cbb582fc5..f348dfdb22 100644 --- a/include/deal.II/base/function_lib.h +++ b/include/deal.II/base/function_lib.h @@ -53,24 +53,24 @@ namespace Functions { public: virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value (const Point &p, - Vector &values) const; + Vector &values) const override; virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_gradient (const Point &p, - std::vector > &gradient) const; + std::vector > &gradient) const override; virtual void gradient_list (const std::vector > &points, std::vector > &gradients, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual double laplacian (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void laplacian_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -87,37 +87,37 @@ namespace Functions { public: virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value_list (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void gradient_list (const std::vector > &points, std::vector > &gradients, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_gradient_list (const std::vector > &, - std::vector > > &) const; + std::vector > > &) const override; /** * Laplacian of the function at one point. */ virtual double laplacian (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Laplacian of the function at multiple points. */ virtual void laplacian_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -151,40 +151,40 @@ namespace Functions * The value at a single point. */ virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Values at multiple points. */ virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Gradient at a single point. */ virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Gradients at multiple points. */ virtual void gradient_list (const std::vector > &points, std::vector > &gradients, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Laplacian at a single point. */ virtual double laplacian (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Laplacian at multiple points. */ virtual void laplacian_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; private: const double offset; }; @@ -210,41 +210,41 @@ namespace Functions CosineFunction (const unsigned int n_components = 1); virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value_list (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void gradient_list (const std::vector > &points, std::vector > &gradients, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual double laplacian (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void laplacian_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Second derivatives at a single point. */ virtual SymmetricTensor<2,dim> hessian (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Second derivatives at multiple points. */ virtual void hessian_list (const std::vector > &points, std::vector > &hessians, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -270,28 +270,28 @@ namespace Functions CosineGradFunction (); virtual double value (const Point &p, - const unsigned int component) const; + const unsigned int component) const override; virtual void vector_value (const Point &p, - Vector &values) const; + Vector &values) const override; virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component) const; + const unsigned int component) const override; virtual void vector_value_list (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component) const; + const unsigned int component) const override; virtual void gradient_list (const std::vector > &points, std::vector > &gradients, - const unsigned int component) const; + const unsigned int component) const override; virtual void vector_gradient_list (const std::vector > &points, - std::vector > > &gradients) const; + std::vector > > &gradients) const override; virtual double laplacian (const Point &p, - const unsigned int component) const; + const unsigned int component) const override; }; @@ -310,40 +310,40 @@ namespace Functions * The value at a single point. */ virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Values at multiple points. */ virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Gradient at a single point. */ virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Gradients at multiple points. */ virtual void gradient_list (const std::vector > &points, std::vector > &gradients, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Laplacian at a single point. */ virtual double laplacian (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Laplacian at multiple points. */ virtual void laplacian_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -363,31 +363,31 @@ namespace Functions { public: virtual double value (const Point<2> &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value_list (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; virtual Tensor<1,2> gradient (const Point<2> &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void gradient_list (const std::vector > &points, std::vector > &gradients, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_gradient_list (const std::vector > &, - std::vector > > &) const; + std::vector > > &) const override; virtual double laplacian (const Point<2> &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void laplacian_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -409,31 +409,31 @@ namespace Functions */ LSingularityGradFunction (); virtual double value (const Point<2> &p, - const unsigned int component) const; + const unsigned int component) const override; virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component) const; + const unsigned int component) const override; virtual void vector_value_list (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; virtual Tensor<1,2> gradient (const Point<2> &p, - const unsigned int component) const; + const unsigned int component) const override; virtual void gradient_list (const std::vector > &points, std::vector > &gradients, - const unsigned int component) const; + const unsigned int component) const override; virtual void vector_gradient_list (const std::vector > &, - std::vector > > &) const; + std::vector > > &) const override; virtual double laplacian (const Point<2> &p, - const unsigned int component) const; + const unsigned int component) const override; virtual void laplacian_list (const std::vector > &points, std::vector &values, - const unsigned int component) const; + const unsigned int component) const override; }; @@ -449,31 +449,31 @@ namespace Functions { public: virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value_list (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void gradient_list (const std::vector > &points, std::vector > &gradients, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_gradient_list (const std::vector > &, - std::vector > > &) const; + std::vector > > &) const override; virtual double laplacian (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void laplacian_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -487,31 +487,31 @@ namespace Functions { public: virtual double value (const Point<2> &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_value_list (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; virtual Tensor<1,2> gradient (const Point<2> &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void gradient_list (const std::vector > &points, std::vector > &gradients, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void vector_gradient_list (const std::vector > &, - std::vector > > &) const; + std::vector > > &) const override; virtual double laplacian (const Point<2> &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; virtual void laplacian_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -546,40 +546,40 @@ namespace Functions * Function value at one point. */ virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Function values at multiple points. */ virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Gradient at one point. */ virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Gradients at multiple points. */ virtual void gradient_list (const std::vector > &points, std::vector > &gradients, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Laplacian of the function at one point. */ virtual double laplacian (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Laplacian of the function at multiple points. */ virtual void laplacian_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Return an estimate for the memory consumption, in bytes, of this @@ -647,20 +647,20 @@ namespace Functions * first component. */ virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Return the gradient of the specified component of the function at the * given point. */ virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Compute the Laplacian of a given component at point p. */ virtual double laplacian (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; private: /** * Stored Fourier coefficients. @@ -699,20 +699,20 @@ namespace Functions * first component. */ virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Return the gradient of the specified component of the function at the * given point. */ virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Compute the Laplacian of a given component at point p. */ virtual double laplacian (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; private: /** * Stored Fourier coefficients. @@ -748,20 +748,20 @@ namespace Functions * first component. */ virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Return the gradient of the specified component of the function at the * given point. */ virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Compute the Laplacian of a given component at point p. */ virtual double laplacian (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; private: /** * Stored Fourier coefficients and weights. @@ -800,20 +800,20 @@ namespace Functions * first component. */ virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Return the gradient of the specified component of the function at the * given point. */ virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Compute the Laplacian of a given component at point p. */ virtual double laplacian (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; private: /** @@ -911,20 +911,20 @@ namespace Functions * Function value at one point. */ virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Function values at multiple points. */ virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Function values at multiple points. */ virtual void vector_value_list (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; }; @@ -956,20 +956,20 @@ namespace Functions * Function value at one point. */ virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Function values at multiple points. */ virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Function values at multiple points. */ virtual void vector_value_list (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; }; @@ -1002,26 +1002,26 @@ namespace Functions * Function value at one point. */ virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Function values at multiple points. */ virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Function values at multiple points. */ virtual void vector_value_list (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; /** * Function gradient at one point. */ virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; }; @@ -1056,7 +1056,7 @@ namespace Functions * Function value at one point. */ virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Return all components of a vector-valued function at a given point. @@ -1065,20 +1065,20 @@ namespace Functions * #n_components. */ virtual void vector_value (const Point &p, - Vector &values) const; + Vector &values) const override; /** * Function values at multiple points. */ virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Function gradient at one point. */ virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; private: /** @@ -1154,7 +1154,7 @@ namespace Functions virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Compute the gradient of the function defined by bilinear interpolation @@ -1170,7 +1170,7 @@ namespace Functions virtual Tensor<1, dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; protected: /** @@ -1260,7 +1260,7 @@ namespace Functions virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; private: /** @@ -1312,7 +1312,7 @@ namespace Functions * Function value at one point. */ virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** @@ -1320,13 +1320,13 @@ namespace Functions */ virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Function gradient at one point. */ virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; private: diff --git a/include/deal.II/base/function_parser.h b/include/deal.II/base/function_parser.h index bf8650e672..6e97863646 100644 --- a/include/deal.II/base/function_parser.h +++ b/include/deal.II/base/function_parser.h @@ -212,7 +212,7 @@ public: * Destructor. Explicitly delete the FunctionParser objects (there is one * for each component of the function). */ - ~FunctionParser(); + ~FunctionParser() override; /** * Type for the constant map. Used by the initialize() method. @@ -291,7 +291,7 @@ public: * component. */ virtual double value (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Return all components of a vector-valued function at the given point @p @@ -300,7 +300,7 @@ public: * values shall have the right size beforehand, i.e. #n_components. */ virtual void vector_value (const Point &p, - Vector &values) const; + Vector &values) const override; /** * @addtogroup Exceptions diff --git a/include/deal.II/base/function_spherical.h b/include/deal.II/base/function_spherical.h index 79b298c6d5..090c5da662 100644 --- a/include/deal.II/base/function_spherical.h +++ b/include/deal.II/base/function_spherical.h @@ -65,7 +65,7 @@ namespace Functions * calls svalue() with it, and returns the result. */ virtual double value (const Point &point, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Return the gradient with respect to the Cartesian coordinates at point @p p. @@ -75,7 +75,7 @@ namespace Functions * coordinates. */ virtual Tensor<1,dim> gradient (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Return the Hessian with respect to the Cartesian coordinates at point @p p. @@ -85,7 +85,7 @@ namespace Functions * Cartesian coordinates. */ virtual SymmetricTensor<2,dim> hessian (const Point &p, - const unsigned int component=0) const; + const unsigned int component=0) const override; std::size_t memory_consumption () const; diff --git a/include/deal.II/base/logstream.h b/include/deal.II/base/logstream.h index 779b3998bb..4ffd8d0a0e 100644 --- a/include/deal.II/base/logstream.h +++ b/include/deal.II/base/logstream.h @@ -138,7 +138,7 @@ public: /** * Destructor. */ - ~LogStream(); + ~LogStream() override; /** diff --git a/include/deal.II/base/parameter_acceptor.h b/include/deal.II/base/parameter_acceptor.h index 2c818a5b99..af7943ae75 100644 --- a/include/deal.II/base/parameter_acceptor.h +++ b/include/deal.II/base/parameter_acceptor.h @@ -356,7 +356,7 @@ public: /** * Destructor. */ - virtual ~ParameterAcceptor(); + virtual ~ParameterAcceptor() override; /** * Call declare_all_parameters(), read the parameters from `filename` (only @@ -590,13 +590,13 @@ public: * Overloads the ParameterAcceptor::declare_parameters function, by calling * @p SourceClass::declare_parameters with @p prm as an argument. */ - virtual void declare_parameters(ParameterHandler &prm); + virtual void declare_parameters(ParameterHandler &prm) override; /** * Overloads the ParameterAcceptor::parse_parameters function, by calling * @p SourceClass::parse_parameters with @p prm as an argument. */ - virtual void parse_parameters(ParameterHandler &prm); + virtual void parse_parameters(ParameterHandler &prm) override; }; diff --git a/include/deal.II/base/parameter_handler.h b/include/deal.II/base/parameter_handler.h index 6da5c1478c..0be3acbf6e 100644 --- a/include/deal.II/base/parameter_handler.h +++ b/include/deal.II/base/parameter_handler.h @@ -863,7 +863,7 @@ public: * safer as we have virtual functions. It actually does nothing * spectacular. */ - virtual ~ParameterHandler () = default; + virtual ~ParameterHandler () override = default; /** * Parse each line from a stream until the stream returns the eof diff --git a/include/deal.II/base/parsed_function.h b/include/deal.II/base/parsed_function.h index e8ddf26256..0e60c59d57 100644 --- a/include/deal.II/base/parsed_function.h +++ b/include/deal.II/base/parsed_function.h @@ -184,7 +184,7 @@ namespace Functions * p. */ virtual void vector_value (const Point &p, - Vector &values) const; + Vector &values) const override; /** * Return the value of the function at the given point. Unless there is @@ -193,7 +193,7 @@ namespace Functions * first component. */ virtual double value (const Point< dim > &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Set the time to a specific value for time-dependent functions. @@ -201,7 +201,7 @@ namespace Functions * We need to overwrite this to set the time also in the accessor * FunctionParser. */ - virtual void set_time(const double newtime); + virtual void set_time(const double newtime) override; private: /** diff --git a/include/deal.II/base/partitioner.h b/include/deal.II/base/partitioner.h index 5ed5ba8131..20afbabe0c 100644 --- a/include/deal.II/base/partitioner.h +++ b/include/deal.II/base/partitioner.h @@ -165,7 +165,7 @@ namespace Utilities */ virtual void reinit(const IndexSet &vector_space_vector_index_set, const IndexSet &read_write_vector_index_set, - const MPI_Comm &communicator); + const MPI_Comm &communicator) override; /** * Set the locally owned indices. Used in the constructor. @@ -356,7 +356,7 @@ namespace Utilities /** * Return the MPI communicator underlying the partitioner object. */ - virtual const MPI_Comm &get_mpi_communicator() const; + virtual const MPI_Comm &get_mpi_communicator() const override; /** * Return whether ghost indices have been explicitly added as a @p diff --git a/include/deal.II/base/patterns.h b/include/deal.II/base/patterns.h index 842d65e91e..d6e03cea57 100644 --- a/include/deal.II/base/patterns.h +++ b/include/deal.II/base/patterns.h @@ -206,21 +206,21 @@ namespace Patterns * Return true if the string is an integer and its value is * within the specified range. */ - virtual bool match (const std::string &test_string) const; + virtual bool match (const std::string &test_string) const override; /** * Return a description of the pattern that valid strings are expected to * match. If bounds were specified to the constructor, then include them * into this description. */ - virtual std::string description (const OutputStyle style=Machine) const; + virtual std::string description (const OutputStyle style=Machine) const override; /** * Return a copy of the present object, which is newly allocated on the * heap. Ownership of that object is transferred to the caller of this * function. */ - virtual std::unique_ptr clone () const; + virtual std::unique_ptr clone () const override; /** * Create a new object if the start of description matches @@ -298,21 +298,21 @@ namespace Patterns * Return true if the string is a number and its value is within * the specified range. */ - virtual bool match (const std::string &test_string) const; + virtual bool match (const std::string &test_string) const override; /** * Return a description of the pattern that valid strings are expected to * match. If bounds were specified to the constructor, then include them * into this description. */ - virtual std::string description (const OutputStyle style=Machine) const; + virtual std::string description (const OutputStyle style=Machine) const override; /** * Return a copy of the present object, which is newly allocated on the * heap. Ownership of that object is transferred to the caller of this * function. */ - virtual std::unique_ptr clone () const; + virtual std::unique_ptr clone () const override; /** * Creates a new object on the heap using @p new if the given @@ -368,27 +368,27 @@ namespace Patterns * Return true if the string is an element of the description * list passed to the constructor. */ - virtual bool match (const std::string &test_string) const; + virtual bool match (const std::string &test_string) const override; /** * Return a description of the pattern that valid strings are expected to * match. Here, this is the list of valid strings passed to the * constructor. */ - virtual std::string description (const OutputStyle style=Machine) const; + virtual std::string description (const OutputStyle style=Machine) const override; /** * Return a copy of the present object, which is newly allocated on the * heap. Ownership of that object is transferred to the caller of this * function. */ - virtual std::unique_ptr clone () const; + virtual std::unique_ptr clone () const override; /** * Determine an estimate for the memory consumption (in bytes) of this * object. */ - std::size_t memory_consumption () const; + std::size_t memory_consumption () const override; /** * Create a new object if the start of description matches @@ -461,20 +461,20 @@ namespace Patterns * Return true if the string is a comma-separated list of strings * each of which match the pattern given to the constructor. */ - virtual bool match (const std::string &test_string) const; + virtual bool match (const std::string &test_string) const override; /** * Return a description of the pattern that valid strings are expected to * match. */ - virtual std::string description (const OutputStyle style=Machine) const; + virtual std::string description (const OutputStyle style=Machine) const override; /** * Return a copy of the present object, which is newly allocated on the * heap. Ownership of that object is transferred to the caller of this * function. */ - virtual std::unique_ptr clone () const; + virtual std::unique_ptr clone () const override; /** * Create a new object if the start of description matches @@ -487,7 +487,7 @@ namespace Patterns * Determine an estimate for the memory consumption (in bytes) of this * object. */ - std::size_t memory_consumption () const; + std::size_t memory_consumption () const override; /** * @addtogroup Exceptions @@ -578,20 +578,20 @@ namespace Patterns * Return true if the string is a comma-separated list of strings * each of which match the pattern given to the constructor. */ - virtual bool match (const std::string &test_string) const; + virtual bool match (const std::string &test_string) const override; /** * Return a description of the pattern that valid strings are expected to * match. */ - virtual std::string description (const OutputStyle style=Machine) const; + virtual std::string description (const OutputStyle style=Machine) const override; /** * Return a copy of the present object, which is newly allocated on the * heap. Ownership of that object is transferred to the caller of this * function. */ - virtual std::unique_ptr clone () const; + virtual std::unique_ptr clone () const override; /** * Create a new object if the start of description matches @@ -604,7 +604,7 @@ namespace Patterns * Determine an estimate for the memory consumption (in bytes) of this * object. */ - std::size_t memory_consumption () const; + std::size_t memory_consumption () const override; /** * Return a reference to the key pattern. @@ -785,20 +785,20 @@ namespace Patterns * Return true if the string is a list of strings * each of which matches the patterns given to the constructor. */ - virtual bool match (const std::string &test_string) const; + virtual bool match (const std::string &test_string) const override; /** * Return a description of the pattern that valid strings are expected to * match. */ - virtual std::string description (const OutputStyle style=Machine) const; + virtual std::string description (const OutputStyle style=Machine) const override; /** * Return a copy of the present object, which is newly allocated on the * heap. Ownership of that object is transferred to the caller of this * function. */ - virtual std::unique_ptr clone () const; + virtual std::unique_ptr clone () const override; /** * Create a new object if the start of description matches @@ -811,7 +811,7 @@ namespace Patterns * Determine an estimate for the memory consumption (in bytes) of this * object. */ - std::size_t memory_consumption () const; + std::size_t memory_consumption () const override; /** * Return a reference to the i-th pattern in the tuple. @@ -863,21 +863,21 @@ namespace Patterns * Return true if the string is an element of the description * list passed to the constructor. */ - virtual bool match (const std::string &test_string) const; + virtual bool match (const std::string &test_string) const override; /** * Return a description of the pattern that valid strings are expected to * match. Here, this is the list of valid strings passed to the * constructor. */ - virtual std::string description (const OutputStyle style=Machine) const; + virtual std::string description (const OutputStyle style=Machine) const override; /** * Return a copy of the present object, which is newly allocated on the * heap. Ownership of that object is transferred to the caller of this * function. */ - virtual std::unique_ptr clone () const; + virtual std::unique_ptr clone () const override; /** * Create a new object if the start of description matches @@ -890,7 +890,7 @@ namespace Patterns * Determine an estimate for the memory consumption (in bytes) of this * object. */ - std::size_t memory_consumption () const; + std::size_t memory_consumption () const override; /** * @addtogroup Exceptions @@ -934,14 +934,14 @@ namespace Patterns * Return a description of the pattern that valid strings are expected to * match. */ - virtual std::string description (const OutputStyle style=Machine) const; + virtual std::string description (const OutputStyle style=Machine) const override; /** * Return a copy of the present object, which is newly allocated on the * heap. Ownership of that object is transferred to the caller of this * function. */ - virtual std::unique_ptr clone () const; + virtual std::unique_ptr clone () const override; /** * Create a new object if the start of description matches @@ -973,20 +973,20 @@ namespace Patterns * Return true if the string matches its constraints, i.e. * always. */ - virtual bool match (const std::string &test_string) const; + virtual bool match (const std::string &test_string) const override; /** * Return a description of the pattern that valid strings are expected to * match. Here, this is the string "[Anything]". */ - virtual std::string description (const OutputStyle style=Machine) const; + virtual std::string description (const OutputStyle style=Machine) const override; /** * Return a copy of the present object, which is newly allocated on the * heap. Ownership of that object is transferred to the caller of this * function. */ - virtual std::unique_ptr clone () const; + virtual std::unique_ptr clone () const override; /** * Create a new object if the start of description matches @@ -1046,20 +1046,20 @@ namespace Patterns * Return true if the string matches its constraints, i.e. * always. */ - virtual bool match (const std::string &test_string) const; + virtual bool match (const std::string &test_string) const override; /** * Return a description of the pattern that valid strings are expected to * match. Here, this is the string "[Filename]". */ - virtual std::string description (const OutputStyle style=Machine) const; + virtual std::string description (const OutputStyle style=Machine) const override; /** * Return a copy of the present object, which is newly allocated on the * heap. Ownership of that object is transferred to the caller of this * function. */ - virtual std::unique_ptr clone () const; + virtual std::unique_ptr clone () const override; /** * file type flag @@ -1105,20 +1105,20 @@ namespace Patterns * Return true if the string matches its constraints, i.e. * always. */ - virtual bool match (const std::string &test_string) const; + virtual bool match (const std::string &test_string) const override; /** * Return a description of the pattern that valid strings are expected to * match. Here, this is the string "[Filename]". */ - virtual std::string description (const OutputStyle style=Machine) const; + virtual std::string description (const OutputStyle style=Machine) const override; /** * Return a copy of the present object, which is newly allocated on the * heap. Ownership of that object is transferred to the caller of this * function. */ - virtual std::unique_ptr clone () const; + virtual std::unique_ptr clone () const override; /** * Create a new object if the start of description matches diff --git a/include/deal.II/base/quadrature.h b/include/deal.II/base/quadrature.h index 73a1a38f3d..20d38355a2 100644 --- a/include/deal.II/base/quadrature.h +++ b/include/deal.II/base/quadrature.h @@ -165,7 +165,7 @@ public: /** * Virtual destructor. */ - virtual ~Quadrature () = default; + virtual ~Quadrature () override = default; /** * Assignment operator. Copies contents of #weights and #quadrature_points diff --git a/include/deal.II/base/quadrature_point_data.h b/include/deal.II/base/quadrature_point_data.h index a9915939aa..83af40c0f3 100644 --- a/include/deal.II/base/quadrature_point_data.h +++ b/include/deal.II/base/quadrature_point_data.h @@ -63,7 +63,7 @@ public: /** * Default destructor. */ - ~CellDataStorage() = default; + ~CellDataStorage() override = default; /** * Initialize data on the @p cell to store @p number_of_data_points_per_cell of objects of type @p T . diff --git a/include/deal.II/base/table.h b/include/deal.II/base/table.h index fe5d043453..85f1a38bef 100644 --- a/include/deal.II/base/table.h +++ b/include/deal.II/base/table.h @@ -454,7 +454,7 @@ public: /** * Destructor. Free allocated memory. */ - ~TableBase () = default; + ~TableBase () override = default; /** * Assignment operator. Copy all elements of src into the matrix. diff --git a/include/deal.II/base/tensor_function.h b/include/deal.II/base/tensor_function.h index 80eae0ef74..5114454c9d 100644 --- a/include/deal.II/base/tensor_function.h +++ b/include/deal.II/base/tensor_function.h @@ -75,7 +75,7 @@ public: * usually not used by their true type, but rather through pointers to this * base class. */ - virtual ~TensorFunction () = default; + virtual ~TensorFunction () override = default; /** * Return the value of the function at the given point. @@ -127,17 +127,17 @@ public: ConstantTensorFunction (const dealii::Tensor &value, const Number initial_time = 0.0); - virtual ~ConstantTensorFunction () = default; + virtual ~ConstantTensorFunction () override = default; - virtual typename dealii::TensorFunction::value_type value (const Point &p) const; + virtual typename dealii::TensorFunction::value_type value (const Point &p) const override; virtual void value_list (const std::vector > &points, - std::vector::value_type> &values) const; + std::vector::value_type> &values) const override; - virtual typename dealii::TensorFunction::gradient_type gradient (const Point &p) const; + virtual typename dealii::TensorFunction::gradient_type gradient (const Point &p) const override; virtual void gradient_list (const std::vector > &points, - std::vector::gradient_type> &gradients) const; + std::vector::gradient_type> &gradients) const override; private: const dealii::Tensor _value; diff --git a/include/deal.II/base/thread_management.h b/include/deal.II/base/thread_management.h index ab8b140c36..beea608858 100644 --- a/include/deal.II/base/thread_management.h +++ b/include/deal.II/base/thread_management.h @@ -1364,7 +1364,7 @@ namespace Threads task_descriptor (task_descriptor) {} - virtual tbb::task *execute () + virtual tbb::task *execute () override { // call the function object and put the return value into the // proper place diff --git a/include/deal.II/base/time_stepping.h b/include/deal.II/base/time_stepping.h index 781b8b58a6..4c197a42c0 100644 --- a/include/deal.II/base/time_stepping.h +++ b/include/deal.II/base/time_stepping.h @@ -128,7 +128,7 @@ namespace TimeStepping /** * Virtual destructor. */ - virtual ~RungeKutta() = default; + virtual ~RungeKutta() override = default; /** * Purely virtual method used to initialize the Runge-Kutta method. @@ -151,7 +151,7 @@ namespace TimeStepping std::vector > &J_inverse, double t, double delta_t, - VectorType &y); + VectorType &y) override; /** * Purely virtual function. This function is used to advance from time @p @@ -220,7 +220,7 @@ namespace TimeStepping /** * Initialize the explicit Runge-Kutta method. */ - void initialize(const runge_kutta_method method); + void initialize(const runge_kutta_method method) override; /** * This function is used to advance from time @p t to t+ @p delta_t. @p f @@ -238,7 +238,7 @@ namespace TimeStepping const std::function &id_minus_tau_J_inverse, double t, double delta_t, - VectorType &y); + VectorType &y) override; /** * This function is used to advance from time @p t to t+ @p delta_t. This @@ -269,7 +269,7 @@ namespace TimeStepping /** * Return the status of the current object. */ - const Status &get_status() const; + const Status &get_status() const override; private: /** @@ -319,7 +319,7 @@ namespace TimeStepping /** * Initialize the implicit Runge-Kutta method. */ - void initialize(const runge_kutta_method method); + void initialize(const runge_kutta_method method) override; /** * This function is used to advance from time @p t to t+ @p delta_t. @p f @@ -337,7 +337,7 @@ namespace TimeStepping const std::function &id_minus_tau_J_inverse, double t, double delta_t, - VectorType &y); + VectorType &y) override; /** * Set the maximum number of iterations and the tolerance used by the @@ -367,7 +367,7 @@ namespace TimeStepping /** * Return the status of the current object. */ - const Status &get_status() const; + const Status &get_status() const override; private: /** @@ -456,7 +456,7 @@ namespace TimeStepping /** * Destructor. */ - ~EmbeddedExplicitRungeKutta() + ~EmbeddedExplicitRungeKutta() override { free_memory(); } @@ -469,7 +469,7 @@ namespace TimeStepping /** * Initialize the embedded explicit Runge-Kutta method. */ - void initialize(const runge_kutta_method method); + void initialize(const runge_kutta_method method) override; /** * This function is used to advance from time @p t to t+ @p delta_t. @p f @@ -487,7 +487,7 @@ namespace TimeStepping const std::function &id_minus_tau_J_inverse, double t, double delta_t, - VectorType &y); + VectorType &y) override; /** * This function is used to advance from time @p t to t+ @p delta_t. This @@ -530,7 +530,7 @@ namespace TimeStepping /** * Return the status of the current object. */ - const Status &get_status() const; + const Status &get_status() const override; private: /** diff --git a/include/deal.II/base/work_stream.h b/include/deal.II/base/work_stream.h index 34c2cdc203..fc61bf1b64 100644 --- a/include/deal.II/base/work_stream.h +++ b/include/deal.II/base/work_stream.h @@ -351,7 +351,7 @@ namespace WorkStream /** * Create an item and return a pointer to it. */ - virtual void *operator () (void *) + virtual void *operator () (void *) override { // find first unused item. we know that there must be one // because we have set the maximal number of tokens in flight @@ -493,7 +493,7 @@ namespace WorkStream /** * Work on an item. */ - void *operator () (void *item) + void *operator () (void *item) override { // first unpack the current item typedef @@ -637,7 +637,7 @@ namespace WorkStream /** * Work on a single item. */ - void *operator () (void *item) + void *operator () (void *item) override { // first unpack the current item typedef diff --git a/include/deal.II/distributed/shared_tria.h b/include/deal.II/distributed/shared_tria.h index 1ed6a8ee15..6e5d1bd4c2 100644 --- a/include/deal.II/distributed/shared_tria.h +++ b/include/deal.II/distributed/shared_tria.h @@ -241,7 +241,7 @@ namespace parallel /** * Destructor. */ - virtual ~Triangulation () = default; + virtual ~Triangulation () override = default; /** * Coarsen and refine the mesh according to refinement and coarsening @@ -251,7 +251,7 @@ namespace parallel * addition of calling dealii::GridTools::partition_triangulation() at * the end. */ - virtual void execute_coarsening_and_refinement (); + virtual void execute_coarsening_and_refinement () override; /** * Create a triangulation. @@ -261,7 +261,7 @@ namespace parallel */ virtual void create_triangulation (const std::vector< Point< spacedim > > &vertices, const std::vector< CellData< dim > > &cells, - const SubCellData &subcelldata); + const SubCellData &subcelldata) override; /** * Copy @p other_tria to this triangulation. @@ -273,7 +273,7 @@ namespace parallel * since it only stores those cells that it owns, one layer of ghost cells around * the ones it locally owns, and a number of artificial cells. */ - virtual void copy_triangulation (const dealii::Triangulation &other_tria); + virtual void copy_triangulation (const dealii::Triangulation &other_tria) override; /** * Read the data of this object from a stream for the purpose of @@ -318,7 +318,7 @@ namespace parallel * Override the function to update the number cache so we can fill data * like @p level_ghost_owners. */ - virtual void update_number_cache (); + virtual void update_number_cache () override; private: diff --git a/include/deal.II/distributed/tria.h b/include/deal.II/distributed/tria.h index d742a651f2..4d3ed769dd 100644 --- a/include/deal.II/distributed/tria.h +++ b/include/deal.II/distributed/tria.h @@ -361,7 +361,7 @@ namespace parallel /** * Destructor. */ - virtual ~Triangulation (); + virtual ~Triangulation () override; /** * Reset this triangulation into a virgin state by deleting all data. @@ -369,7 +369,7 @@ namespace parallel * Note that this operation is only allowed if no subscriptions to this * object exist any more, such as DoFHandler objects using it. */ - virtual void clear (); + virtual void clear () override; /** * Implementation of the same function as in the base class. @@ -380,7 +380,7 @@ namespace parallel * parallel::distributed::Triangulation but only if the serial * Triangulation has never been refined. */ - virtual void copy_triangulation (const dealii::Triangulation &other_tria); + virtual void copy_triangulation (const dealii::Triangulation &other_tria) override; /** * Create a triangulation as documented in the base class. @@ -393,7 +393,7 @@ namespace parallel */ virtual void create_triangulation (const std::vector > &vertices, const std::vector > &cells, - const SubCellData &subcelldata); + const SubCellData &subcelldata) override; /** * Coarsen and refine the mesh according to refinement and coarsening @@ -424,7 +424,7 @@ namespace parallel * function is connected to the signal it will be used to balance the * calculated weights, otherwise the number of cells is balanced. */ - virtual void execute_coarsening_and_refinement (); + virtual void execute_coarsening_and_refinement () override; /** * Override the implementation of prepare_coarsening_and_refinement from @@ -432,7 +432,7 @@ namespace parallel * and the level difference over vertices over the periodic boundary * must be not more than 2:1. */ - virtual bool prepare_coarsening_and_refinement (); + virtual bool prepare_coarsening_and_refinement () override; /** * Manually repartition the active cells between processors. Normally @@ -548,12 +548,12 @@ namespace parallel * mesh, i.e., the union of locally owned cells on all processors. */ virtual - bool has_hanging_nodes() const; + bool has_hanging_nodes() const override; /** * Return the local memory consumption in bytes. */ - virtual std::size_t memory_consumption () const; + virtual std::size_t memory_consumption () const override; /** * Return the local memory consumption contained in the p4est data @@ -799,7 +799,7 @@ namespace parallel */ virtual void add_periodicity - (const std::vector > &); + (const std::vector > &) override; private: @@ -808,7 +808,7 @@ namespace parallel * Override the function to update the number cache so we can fill data * like @p level_ghost_owners. */ - virtual void update_number_cache (); + virtual void update_number_cache () override; /** * store the Settings. @@ -970,7 +970,7 @@ namespace parallel * are adjacent to each vertex. */ virtual std::map > - compute_vertices_with_ghost_neighbors () const; + compute_vertices_with_ghost_neighbors () const override; /** * This method returns a bit vector of length tria.n_vertices() @@ -1022,7 +1022,7 @@ namespace parallel /** * Destructor. */ - virtual ~Triangulation (); + virtual ~Triangulation () override; /** * Return a permutation vector for the order the coarse cells are @@ -1116,21 +1116,21 @@ namespace parallel * Like above, this method, which is only implemented for dim = 2 or 3, * needs a stub because it is used in dof_handler_policy.cc */ - std::map > - compute_vertices_with_ghost_neighbors () const; + virtual std::map > + compute_vertices_with_ghost_neighbors () const override; /** * Like above, this method, which is only implemented for dim = 2 or 3, * needs a stub because it is used in dof_handler_policy.cc */ - std::map > + virtual std::map > compute_level_vertices_with_ghost_neighbors (const unsigned int level) const; /** * Like above, this method, which is only implemented for dim = 2 or 3, * needs a stub because it is used in dof_handler_policy.cc */ - std::vector + virtual std::vector mark_locally_active_vertices_on_level(const unsigned int level) const; }; diff --git a/include/deal.II/distributed/tria_base.h b/include/deal.II/distributed/tria_base.h index 8875bf0e9d..aaa82082d8 100644 --- a/include/deal.II/distributed/tria_base.h +++ b/include/deal.II/distributed/tria_base.h @@ -56,7 +56,7 @@ namespace parallel /** * Destructor. */ - virtual ~Triangulation (); + virtual ~Triangulation () override; /** * Return MPI communicator used by this triangulation. @@ -66,7 +66,7 @@ namespace parallel /** * Implementation of the same function as in the base class. */ - virtual void copy_triangulation (const dealii::Triangulation &old_tria); + virtual void copy_triangulation (const dealii::Triangulation &old_tria) override; /** * Return the number of active cells owned by each of the MPI processes @@ -103,12 +103,12 @@ namespace parallel * by each processor. This equals the overall number of active cells in * the triangulation. */ - virtual types::global_dof_index n_global_active_cells () const; + virtual types::global_dof_index n_global_active_cells () const override; /** * Return the local memory consumption in bytes. */ - virtual std::size_t memory_consumption () const; + virtual std::size_t memory_consumption () const override; /** @@ -118,7 +118,7 @@ namespace parallel * the domain that are not very refined, but if other processors store * cells in more deeply refined parts of the domain. */ - virtual unsigned int n_global_levels () const; + virtual unsigned int n_global_levels () const override; /** * Return the subdomain id of those cells that are owned by the current @@ -126,7 +126,7 @@ namespace parallel * subdomain id are either owned by another processor or have children * that only exist on other processors. */ - types::subdomain_id locally_owned_subdomain () const; + types::subdomain_id locally_owned_subdomain () const override; /** * Return a set of MPI ranks of the processors that have at least one diff --git a/include/deal.II/dofs/dof_handler.h b/include/deal.II/dofs/dof_handler.h index 52eda97d20..86894f1a4f 100644 --- a/include/deal.II/dofs/dof_handler.h +++ b/include/deal.II/dofs/dof_handler.h @@ -352,7 +352,7 @@ public: /** * Destructor. */ - virtual ~DoFHandler (); + virtual ~DoFHandler () override; /** * Copy operator. DoFHandler objects are large and expensive. diff --git a/include/deal.II/dofs/dof_handler_policy.h b/include/deal.II/dofs/dof_handler_policy.h index a857e4a52e..290f644675 100644 --- a/include/deal.II/dofs/dof_handler_policy.h +++ b/include/deal.II/dofs/dof_handler_policy.h @@ -124,23 +124,23 @@ namespace internal // documentation is inherited virtual NumberCache - distribute_dofs () const; + distribute_dofs () const override; // documentation is inherited virtual std::vector - distribute_mg_dofs () const; + distribute_mg_dofs () const override; // documentation is inherited virtual NumberCache - renumber_dofs (const std::vector &new_numbers) const; + renumber_dofs (const std::vector &new_numbers) const override; // documentation is inherited virtual NumberCache renumber_mg_dofs (const unsigned int level, - const std::vector &new_numbers) const; + const std::vector &new_numbers) const override; protected: /** @@ -176,14 +176,14 @@ namespace internal */ virtual NumberCache - distribute_dofs () const; + distribute_dofs () const override; /** * This function is not yet implemented. */ virtual std::vector - distribute_mg_dofs () const; + distribute_mg_dofs () const override; /** * Renumber degrees of freedom as specified by the first argument. @@ -196,13 +196,13 @@ namespace internal */ virtual NumberCache - renumber_dofs (const std::vector &new_numbers) const; + renumber_dofs (const std::vector &new_numbers) const override; // documentation is inherited virtual NumberCache renumber_mg_dofs (const unsigned int level, - const std::vector &new_numbers) const; + const std::vector &new_numbers) const override; private: /** @@ -230,23 +230,23 @@ namespace internal // documentation is inherited virtual NumberCache - distribute_dofs () const; + distribute_dofs () const override; // documentation is inherited virtual std::vector - distribute_mg_dofs () const; + distribute_mg_dofs () const override; // documentation is inherited virtual NumberCache - renumber_dofs (const std::vector &new_numbers) const; + renumber_dofs (const std::vector &new_numbers) const override; // documentation is inherited virtual NumberCache renumber_mg_dofs (const unsigned int level, - const std::vector &new_numbers) const; + const std::vector &new_numbers) const override; private: /** diff --git a/include/deal.II/fe/fe.h b/include/deal.II/fe/fe.h index dfb2b06922..1ac39985b0 100644 --- a/include/deal.II/fe/fe.h +++ b/include/deal.II/fe/fe.h @@ -768,7 +768,7 @@ public: * Virtual destructor. Makes sure that pointers to this class are deleted * properly. */ - virtual ~FiniteElement () = default; + virtual ~FiniteElement () override = default; /** * Creates information for creating a FESystem with this class as diff --git a/include/deal.II/fe/fe_abf.h b/include/deal.II/fe/fe_abf.h index cc6e97cbf5..00c144f45a 100644 --- a/include/deal.II/fe/fe_abf.h +++ b/include/deal.II/fe/fe_abf.h @@ -111,7 +111,7 @@ public: * returns FE_ABF(degree), with @p dim and @p degree replaced * by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; /** * This function returns @p true, if the shape function @p shape_index has @@ -121,19 +121,19 @@ public: * always @p true. */ virtual bool has_support_on_face (const unsigned int shape_index, - const unsigned int face_index) const; + const unsigned int face_index) const override; // documentation inherited from the base class virtual void convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + std::vector &nodal_values) const override; - virtual std::size_t memory_consumption () const; + virtual std::size_t memory_consumption () const override; virtual std::unique_ptr > - clone() const; + clone() const override; private: /** diff --git a/include/deal.II/fe/fe_bdm.h b/include/deal.II/fe/fe_bdm.h index e0a0f1885b..847a12590a 100644 --- a/include/deal.II/fe/fe_bdm.h +++ b/include/deal.II/fe/fe_bdm.h @@ -70,17 +70,17 @@ public: * returns FE_BDM(degree), with @p dim and @p degree replaced * by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; virtual std::unique_ptr > - clone() const; + clone() const override; // documentation inherited from the base class virtual void convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + std::vector &nodal_values) const override; private: /** diff --git a/include/deal.II/fe/fe_bernstein.h b/include/deal.II/fe/fe_bernstein.h index 689f151048..32ead15dc9 100644 --- a/include/deal.II/fe/fe_bernstein.h +++ b/include/deal.II/fe/fe_bernstein.h @@ -79,7 +79,7 @@ public: */ virtual void get_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * FE_Bernstein is not interpolatory in the element interior, which prevents @@ -90,7 +90,7 @@ public: */ virtual const FullMatrix & get_restriction_matrix (const unsigned int child, - const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const; + const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const override; /** * FE_Bernstein is not interpolatory in the element interior, which prevents @@ -101,7 +101,7 @@ public: */ virtual const FullMatrix & get_prolongation_matrix (const unsigned int child, - const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const; + const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const override; /** * Return the matrix interpolating from a face of one element to the face of @@ -114,7 +114,7 @@ public: */ virtual void get_face_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * Return the matrix interpolating from a face of one element to the face of @@ -128,13 +128,13 @@ public: virtual void get_subface_interpolation_matrix (const FiniteElement &source, const unsigned int subface, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * Return whether this element implements its hanging node constraints in * the new way, which has to be used to make elements "hp compatible". */ - virtual bool hp_constraints_are_implemented () const; + virtual bool hp_constraints_are_implemented () const override; /** * If, on a vertex, several finite elements are active, the hp code first @@ -153,7 +153,7 @@ public: */ virtual std::vector > - hp_vertex_dof_identities (const FiniteElement &fe_other) const; + hp_vertex_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -161,7 +161,7 @@ public: */ virtual std::vector > - hp_line_dof_identities (const FiniteElement &fe_other) const; + hp_line_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -169,7 +169,7 @@ public: */ virtual std::vector > - hp_quad_dof_identities (const FiniteElement &fe_other) const; + hp_quad_dof_identities (const FiniteElement &fe_other) const override; /** * Return whether this element dominates the one given as argument when they @@ -182,7 +182,7 @@ public: */ virtual FiniteElementDomination::Domination - compare_for_face_domination (const FiniteElement &fe_other) const; + compare_for_face_domination (const FiniteElement &fe_other) const override; /** @@ -190,11 +190,11 @@ public: * returns FE_Bernstein(degree), with @p dim and @p degree * replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; virtual std::unique_ptr > - clone() const; + clone() const override; protected: diff --git a/include/deal.II/fe/fe_dg_vector.h b/include/deal.II/fe/fe_dg_vector.h index 6941173213..4ce3f3278f 100644 --- a/include/deal.II/fe/fe_dg_vector.h +++ b/include/deal.II/fe/fe_dg_vector.h @@ -65,11 +65,11 @@ public: * returns FE_RaviartThomas(degree), with @p dim and @p degree * replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; virtual std::unique_ptr > - clone() const; + clone() const override; /** * This function returns @p true, if the shape function @p shape_index has @@ -78,9 +78,9 @@ public: * For this element, we always return @p true. */ virtual bool has_support_on_face (const unsigned int shape_index, - const unsigned int face_index) const; + const unsigned int face_index) const override; - virtual std::size_t memory_consumption () const; + virtual std::size_t memory_consumption () const override; private: /** @@ -152,7 +152,7 @@ public: * returns FE_DGNedelec(degree), with @p dim and @p degree * replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; }; @@ -179,7 +179,7 @@ public: * returns FE_DGRaviartThomas(degree), with @p dim and @p * degree replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; }; @@ -205,7 +205,7 @@ public: * returns FE_DGBDM(degree), with @p dim and @p degree * replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; }; diff --git a/include/deal.II/fe/fe_dgp.h b/include/deal.II/fe/fe_dgp.h index 6f9bc455ba..2d961f5349 100644 --- a/include/deal.II/fe/fe_dgp.h +++ b/include/deal.II/fe/fe_dgp.h @@ -319,7 +319,7 @@ public: * returns FE_DGP(degree), with @p dim and @p degree replaced * by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; /** * @name Functions to support hp @@ -346,7 +346,7 @@ public: */ virtual std::vector > - hp_vertex_dof_identities (const FiniteElement &fe_other) const; + hp_vertex_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -357,7 +357,7 @@ public: */ virtual std::vector > - hp_line_dof_identities (const FiniteElement &fe_other) const; + hp_line_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -368,7 +368,7 @@ public: */ virtual std::vector > - hp_quad_dof_identities (const FiniteElement &fe_other) const; + hp_quad_dof_identities (const FiniteElement &fe_other) const override; /** * Return whether this element implements its hanging node constraints in @@ -378,7 +378,7 @@ public: * of the element), as it has no hanging nodes (being a discontinuous * element). */ - virtual bool hp_constraints_are_implemented () const; + virtual bool hp_constraints_are_implemented () const override; /** * Return whether this element dominates the one given as argument when they @@ -391,7 +391,7 @@ public: */ virtual FiniteElementDomination::Domination - compare_for_face_domination (const FiniteElement &fe_other) const; + compare_for_face_domination (const FiniteElement &fe_other) const override; /** * @} @@ -410,7 +410,7 @@ public: */ virtual void get_face_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * Return the matrix interpolating from a face of one element to the face @@ -426,14 +426,14 @@ public: virtual void get_subface_interpolation_matrix (const FiniteElement &source, const unsigned int subface, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * This function returns @p true, if the shape function @p shape_index has * non-zero function values somewhere on the face @p face_index. */ virtual bool has_support_on_face (const unsigned int shape_index, - const unsigned int face_index) const; + const unsigned int face_index) const override; /** * Determine an estimate for the memory consumption (in bytes) of this @@ -443,7 +443,7 @@ public: * accessed through pointers to their base class, rather than the class * itself. */ - virtual std::size_t memory_consumption () const; + virtual std::size_t memory_consumption () const override; /** @@ -451,11 +451,11 @@ public: * first entry is true, all other are false. */ virtual std::pair, std::vector > - get_constant_modes () const; + get_constant_modes () const override; virtual std::unique_ptr > - clone() const; + clone() const override; private: diff --git a/include/deal.II/fe/fe_dgp_monomial.h b/include/deal.II/fe/fe_dgp_monomial.h index 7b49e58b95..c701a86758 100644 --- a/include/deal.II/fe/fe_dgp_monomial.h +++ b/include/deal.II/fe/fe_dgp_monomial.h @@ -294,7 +294,7 @@ public: * returns FE_DGPMonomial(degree), with dim and * p replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; /** * @name Functions to support hp @@ -321,7 +321,7 @@ public: */ virtual std::vector > - hp_vertex_dof_identities (const FiniteElement &fe_other) const; + hp_vertex_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -332,7 +332,7 @@ public: */ virtual std::vector > - hp_line_dof_identities (const FiniteElement &fe_other) const; + hp_line_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -343,7 +343,7 @@ public: */ virtual std::vector > - hp_quad_dof_identities (const FiniteElement &fe_other) const; + hp_quad_dof_identities (const FiniteElement &fe_other) const override; /** * Return whether this element implements its hanging node constraints in @@ -353,7 +353,7 @@ public: * the degree of the element), as it has no hanging nodes (being a * discontinuous element). */ - virtual bool hp_constraints_are_implemented () const; + virtual bool hp_constraints_are_implemented () const override; /** * Return whether this element dominates the one given as argument when they @@ -366,7 +366,7 @@ public: */ virtual FiniteElementDomination::Domination - compare_for_face_domination (const FiniteElement &fe_other) const; + compare_for_face_domination (const FiniteElement &fe_other) const override; /** * @} @@ -383,7 +383,7 @@ public: */ virtual void get_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * Return the matrix interpolating from a face of one element to the face @@ -398,7 +398,7 @@ public: */ virtual void get_face_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * Return the matrix interpolating from a face of one element to the face @@ -414,14 +414,14 @@ public: virtual void get_subface_interpolation_matrix (const FiniteElement &source, const unsigned int subface, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * This function returns @p true, if the shape function @p shape_index has * non-zero function values somewhere on the face @p face_index. */ virtual bool has_support_on_face (const unsigned int shape_index, - const unsigned int face_index) const; + const unsigned int face_index) const override; /** * Determine an estimate for the memory consumption (in bytes) of this @@ -431,11 +431,11 @@ public: * accessed through pointers to their base class, rather than the class * itself. */ - virtual std::size_t memory_consumption () const; + virtual std::size_t memory_consumption () const override; virtual std::unique_ptr > - clone() const; + clone() const override; private: diff --git a/include/deal.II/fe/fe_dgp_nonparametric.h b/include/deal.II/fe/fe_dgp_nonparametric.h index dd01fa1899..5c5d382887 100644 --- a/include/deal.II/fe/fe_dgp_nonparametric.h +++ b/include/deal.II/fe/fe_dgp_nonparametric.h @@ -279,16 +279,16 @@ public: * returns FE_DGPNonparametric(degree), with @p dim and @p * degree replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; virtual std::unique_ptr > - clone() const; + clone() const override; // for documentation, see the FiniteElement base class virtual UpdateFlags - requires_update_flags (const UpdateFlags update_flags) const; + requires_update_flags (const UpdateFlags update_flags) const override; /** * This function is intended to return the value of a shape function at a @@ -301,7 +301,7 @@ public: * type FiniteElement::ExcUnitShapeValuesDoNotExist. */ virtual double shape_value (const unsigned int i, - const Point &p) const; + const Point &p) const override; /** * This function is intended to return the value of a shape function at a @@ -315,7 +315,7 @@ public: */ virtual double shape_value_component (const unsigned int i, const Point &p, - const unsigned int component) const; + const unsigned int component) const override; /** * This function is intended to return the gradient of a shape function at a @@ -328,7 +328,7 @@ public: * type FiniteElement::ExcUnitShapeValuesDoNotExist. */ virtual Tensor<1,dim> shape_grad (const unsigned int i, - const Point &p) const; + const Point &p) const override; /** * This function is intended to return the gradient of a shape function at a @@ -342,7 +342,7 @@ public: */ virtual Tensor<1,dim> shape_grad_component (const unsigned int i, const Point &p, - const unsigned int component) const; + const unsigned int component) const override; /** * This function is intended to return the Hessian of a shape function at a @@ -355,7 +355,7 @@ public: * exception of type FiniteElement::ExcUnitShapeValuesDoNotExist. */ virtual Tensor<2,dim> shape_grad_grad (const unsigned int i, - const Point &p) const; + const Point &p) const override; /** * This function is intended to return the Hessian of a shape function at a @@ -369,7 +369,7 @@ public: */ virtual Tensor<2,dim> shape_grad_grad_component (const unsigned int i, const Point &p, - const unsigned int component) const; + const unsigned int component) const override; /** * Return the polynomial degree of this finite element, i.e. the value @@ -390,7 +390,7 @@ public: */ virtual void get_face_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * Return the matrix interpolating from a face of one element to the face @@ -406,7 +406,7 @@ public: virtual void get_subface_interpolation_matrix (const FiniteElement &source, const unsigned int subface, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * @name Functions to support hp @@ -433,7 +433,7 @@ public: */ virtual std::vector > - hp_vertex_dof_identities (const FiniteElement &fe_other) const; + hp_vertex_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -444,7 +444,7 @@ public: */ virtual std::vector > - hp_line_dof_identities (const FiniteElement &fe_other) const; + hp_line_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -455,7 +455,7 @@ public: */ virtual std::vector > - hp_quad_dof_identities (const FiniteElement &fe_other) const; + hp_quad_dof_identities (const FiniteElement &fe_other) const override; /** * Return whether this element implements its hanging node constraints in @@ -465,7 +465,7 @@ public: * of the degree of the element), as it has no hanging nodes (being a * discontinuous element). */ - virtual bool hp_constraints_are_implemented () const; + virtual bool hp_constraints_are_implemented () const override; /** * Return whether this element dominates the one given as argument when they @@ -478,7 +478,7 @@ public: */ virtual FiniteElementDomination::Domination - compare_for_face_domination (const FiniteElement &fe_other) const; + compare_for_face_domination (const FiniteElement &fe_other) const override; /** * @} @@ -489,7 +489,7 @@ public: * non-zero function values somewhere on the face @p face_index. */ virtual bool has_support_on_face (const unsigned int shape_index, - const unsigned int face_index) const; + const unsigned int face_index) const override; /** * Determine an estimate for the memory consumption (in bytes) of this @@ -499,7 +499,7 @@ public: * accessed through pointers to their base class, rather than the class * itself. */ - virtual std::size_t memory_consumption () const; + virtual std::size_t memory_consumption () const override; protected: @@ -512,7 +512,7 @@ protected: get_data (const UpdateFlags update_flags, const Mapping &mapping, const Quadrature &quadrature, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; virtual void @@ -523,7 +523,7 @@ protected: const typename Mapping::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; virtual void @@ -534,7 +534,7 @@ protected: const typename Mapping::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; virtual void @@ -546,7 +546,7 @@ protected: const typename Mapping::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; private: diff --git a/include/deal.II/fe/fe_dgq.h b/include/deal.II/fe/fe_dgq.h index 6e927daac1..7e185287ee 100644 --- a/include/deal.II/fe/fe_dgq.h +++ b/include/deal.II/fe/fe_dgq.h @@ -118,7 +118,7 @@ public: * returns FE_DGQ(degree), with dim and * degree replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; /** * Return the matrix interpolating from the given finite element to the @@ -131,7 +131,7 @@ public: */ virtual void get_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * Return the matrix interpolating from a face of one element to the face @@ -146,7 +146,7 @@ public: */ virtual void get_face_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * Return the matrix interpolating from a face of one element to the face @@ -162,7 +162,7 @@ public: virtual void get_subface_interpolation_matrix (const FiniteElement &source, const unsigned int subface, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * Projection from a fine grid space onto a coarse grid space. Overrides the @@ -183,7 +183,7 @@ public: */ virtual const FullMatrix & get_restriction_matrix (const unsigned int child, - const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const; + const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const override; /** * Embedding matrix between grids. Overrides the respective method in @@ -208,7 +208,7 @@ public: */ virtual const FullMatrix & get_prolongation_matrix (const unsigned int child, - const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const; + const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const override; /** * @name Functions to support hp @@ -235,7 +235,7 @@ public: */ virtual std::vector > - hp_vertex_dof_identities (const FiniteElement &fe_other) const; + hp_vertex_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -246,7 +246,7 @@ public: */ virtual std::vector > - hp_line_dof_identities (const FiniteElement &fe_other) const; + hp_line_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -257,7 +257,7 @@ public: */ virtual std::vector > - hp_quad_dof_identities (const FiniteElement &fe_other) const; + hp_quad_dof_identities (const FiniteElement &fe_other) const override; /** * Return whether this element implements its hanging node constraints in @@ -267,7 +267,7 @@ public: * of the element), as it has no hanging nodes (being a discontinuous * element). */ - virtual bool hp_constraints_are_implemented () const; + virtual bool hp_constraints_are_implemented () const override; /** * Return whether this element dominates the one given as argument when they @@ -280,7 +280,7 @@ public: */ virtual FiniteElementDomination::Domination - compare_for_face_domination (const FiniteElement &fe_other) const; + compare_for_face_domination (const FiniteElement &fe_other) const override; /** * @} @@ -291,14 +291,14 @@ public: * non-zero function values somewhere on the face @p face_index. */ virtual bool has_support_on_face (const unsigned int shape_index, - const unsigned int face_index) const; + const unsigned int face_index) const override; /** * Return a list of constant modes of the element. For this element, it * simply returns one row with all entries set to true. */ virtual std::pair, std::vector > - get_constant_modes () const; + get_constant_modes () const override; /** * Implementation of the corresponding function in the FiniteElement @@ -310,7 +310,7 @@ public: virtual void convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + std::vector &nodal_values) const override; /** * Determine an estimate for the memory consumption (in bytes) of this @@ -320,11 +320,11 @@ public: * accessed through pointers to their base class, rather than the class * itself. */ - virtual std::size_t memory_consumption () const; + virtual std::size_t memory_consumption () const override; virtual std::unique_ptr > - clone() const; + clone() const override; protected: /** @@ -416,7 +416,7 @@ public: * returns FE_DGQArbitraryNodes(degree), with dim and * degree replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; /** * Implementation of the corresponding function in the FiniteElement @@ -428,10 +428,10 @@ public: virtual void convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + std::vector &nodal_values) const override; virtual std::unique_ptr > - clone() const; + clone() const override; }; @@ -462,7 +462,7 @@ public: * mode) is set to true and all other elements are set to false. */ virtual std::pair, std::vector > - get_constant_modes () const; + get_constant_modes () const override; /** * Return a string that uniquely identifies a finite element. This class @@ -470,11 +470,11 @@ public: * degree replaced by the values given by the template parameter * and the argument passed to the constructor, respectively. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; virtual std::unique_ptr > - clone() const; + clone() const override; }; @@ -512,11 +512,11 @@ public: * degree replaced by the values given by the template parameter * and the argument passed to the constructor, respectively. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; virtual std::unique_ptr > - clone() const; + clone() const override; }; diff --git a/include/deal.II/fe/fe_enriched.h b/include/deal.II/fe/fe_enriched.h index 279b0230ae..ceec91b7df 100644 --- a/include/deal.II/fe/fe_enriched.h +++ b/include/deal.II/fe/fe_enriched.h @@ -281,16 +281,16 @@ public: virtual std::unique_ptr > - clone() const; + clone() const override; virtual UpdateFlags - requires_update_flags (const UpdateFlags update_flags) const; + requires_update_flags (const UpdateFlags update_flags) const override; /** * Return a string that identifies a finite element. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; /** * Access to a composing element. The index needs to be smaller than the @@ -299,7 +299,7 @@ public: * element to be enriched, which could be FE_Nothing. */ virtual const FiniteElement & - base_element (const unsigned int index) const; + base_element (const unsigned int index) const override; /** * Return the value of the @p ith shape function at the point @p p. @p p is a @@ -310,7 +310,7 @@ public: * real-space. */ virtual double shape_value(const unsigned int i, - const Point< dim > &p) const; + const Point< dim > &p) const override; /** * @name Transfer matrices @@ -325,7 +325,7 @@ public: */ virtual const FullMatrix & get_restriction_matrix (const unsigned int child, - const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const; + const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const override; /** * Embedding matrix between grids. @@ -335,7 +335,7 @@ public: */ virtual const FullMatrix & get_prolongation_matrix (const unsigned int child, - const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const; + const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const override; //@} @@ -350,7 +350,7 @@ public: * This function returns @p true if and only if all its base elements return @p true * for this function. */ - virtual bool hp_constraints_are_implemented () const; + virtual bool hp_constraints_are_implemented () const override; /** * Return the matrix interpolating from a face of one element to the face @@ -366,7 +366,7 @@ public: */ virtual void get_face_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * Return the matrix interpolating from a face of one element to the @@ -383,7 +383,7 @@ public: virtual void get_subface_interpolation_matrix (const FiniteElement &source, const unsigned int subface, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * If, on a vertex, several finite elements are active, the hp code first @@ -402,7 +402,7 @@ public: */ virtual std::vector > - hp_vertex_dof_identities (const FiniteElement &fe_other) const; + hp_vertex_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -410,7 +410,7 @@ public: */ virtual std::vector > - hp_line_dof_identities (const FiniteElement &fe_other) const; + hp_line_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -418,7 +418,7 @@ public: */ virtual std::vector > - hp_quad_dof_identities (const FiniteElement &fe_other) const; + hp_quad_dof_identities (const FiniteElement &fe_other) const override; /** * Return whether this element dominates the one given as argument when they @@ -431,7 +431,7 @@ public: */ virtual FiniteElementDomination::Domination - compare_for_face_domination (const FiniteElement &fe_other) const; + compare_for_face_domination (const FiniteElement &fe_other) const override; //@} @@ -567,19 +567,19 @@ protected: get_data (const UpdateFlags flags, const Mapping &mapping, const Quadrature &quadrature, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &output_data) const override; virtual std::unique_ptr::InternalDataBase> get_face_data (const UpdateFlags update_flags, const Mapping &mapping, const Quadrature &quadrature, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &output_data) const override; virtual std::unique_ptr::InternalDataBase> get_subface_data (const UpdateFlags update_flags, const Mapping &mapping, const Quadrature &quadrature, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; virtual void fill_fe_values (const typename Triangulation::cell_iterator &cell, @@ -590,7 +590,7 @@ protected: const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fe_internal, dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data - ) const; + ) const override; virtual void @@ -602,7 +602,7 @@ protected: const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fe_internal, dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data - ) const; + ) const override; virtual void @@ -615,7 +615,7 @@ protected: const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fe_internal, dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data - ) const; + ) const override; private: /** diff --git a/include/deal.II/fe/fe_face.h b/include/deal.II/fe/fe_face.h index 6592ccd8c9..e469dd9640 100644 --- a/include/deal.II/fe/fe_face.h +++ b/include/deal.II/fe/fe_face.h @@ -64,14 +64,14 @@ public: virtual std::unique_ptr > - clone() const; + clone() const override; /** * Return a string that uniquely identifies a finite element. This class * returns FE_FaceQ(degree), with dim and * degree replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; /** * Implementation of the corresponding function in the FiniteElement @@ -83,7 +83,7 @@ public: virtual void convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + std::vector &nodal_values) const override; /** * Return the matrix interpolating from a face of one element to the face @@ -95,7 +95,7 @@ public: */ virtual void get_face_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * Return the matrix interpolating from a face of one element to the face @@ -108,14 +108,14 @@ public: virtual void get_subface_interpolation_matrix (const FiniteElement &source, const unsigned int subface, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * This function returns @p true, if the shape function @p shape_index has * non-zero function values somewhere on the face @p face_index. */ virtual bool has_support_on_face (const unsigned int shape_index, - const unsigned int face_index) const; + const unsigned int face_index) const override; /** * @name Functions to support hp @@ -141,7 +141,7 @@ public: */ virtual std::vector > - hp_vertex_dof_identities (const FiniteElement &fe_other) const; + hp_vertex_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -151,7 +151,7 @@ public: */ virtual std::vector > - hp_line_dof_identities (const FiniteElement &fe_other) const; + hp_line_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -161,13 +161,13 @@ public: */ virtual std::vector > - hp_quad_dof_identities (const FiniteElement &fe_other) const; + hp_quad_dof_identities (const FiniteElement &fe_other) const override; /** * Return whether this element implements its hanging node constraints in * the new way, which has to be used to make elements "hp compatible". */ - virtual bool hp_constraints_are_implemented () const; + virtual bool hp_constraints_are_implemented () const override; /** * Return whether this element dominates the one given as argument when they @@ -180,7 +180,7 @@ public: */ virtual FiniteElementDomination::Domination - compare_for_face_domination (const FiniteElement &fe_other) const; + compare_for_face_domination (const FiniteElement &fe_other) const override; /** * @} */ @@ -190,7 +190,7 @@ public: * simply returns one row with all entries set to true. */ virtual std::pair, std::vector > - get_constant_modes () const; + get_constant_modes () const override; private: /** @@ -224,19 +224,19 @@ public: virtual std::unique_ptr> - clone() const; + clone() const override; /** * Return a string that uniquely identifies a finite element. This class * returns FE_FaceQ(degree), with dim and * degree replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; // for documentation, see the FiniteElement base class virtual UpdateFlags - requires_update_flags (const UpdateFlags update_flags) const; + requires_update_flags (const UpdateFlags update_flags) const override; /** * Return the matrix interpolating from a face of one element to the face @@ -248,7 +248,7 @@ public: */ virtual void get_face_interpolation_matrix (const FiniteElement<1,spacedim> &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * Return the matrix interpolating from a face of one element to the face @@ -261,20 +261,20 @@ public: virtual void get_subface_interpolation_matrix (const FiniteElement<1,spacedim> &source, const unsigned int subface, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * This function returns @p true, if the shape function @p shape_index has * non-zero function values somewhere on the face @p face_index. */ virtual bool has_support_on_face (const unsigned int shape_index, - const unsigned int face_index) const; + const unsigned int face_index) const override; /** * Return whether this element implements its hanging node constraints in * the new way, which has to be used to make elements "hp compatible". */ - virtual bool hp_constraints_are_implemented () const; + virtual bool hp_constraints_are_implemented () const override; /** * If, on a vertex, several finite elements are active, the hp code first @@ -295,7 +295,7 @@ public: */ virtual std::vector > - hp_vertex_dof_identities (const FiniteElement<1, spacedim> &fe_other) const; + hp_vertex_dof_identities (const FiniteElement<1, spacedim> &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -305,7 +305,7 @@ public: */ virtual std::vector > - hp_line_dof_identities (const FiniteElement<1, spacedim> &fe_other) const; + hp_line_dof_identities (const FiniteElement<1, spacedim> &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -315,7 +315,7 @@ public: */ virtual std::vector > - hp_quad_dof_identities (const FiniteElement<1, spacedim> &fe_other) const; + hp_quad_dof_identities (const FiniteElement<1, spacedim> &fe_other) const override; /** * Return whether this element dominates the one given as argument when they @@ -328,14 +328,14 @@ public: */ virtual FiniteElementDomination::Domination - compare_for_face_domination (const FiniteElement<1,spacedim> &fe_other) const; + compare_for_face_domination (const FiniteElement<1,spacedim> &fe_other) const override; /** * Return a list of constant modes of the element. For this element, it * simply returns one row with all entries set to true. */ virtual std::pair, std::vector > - get_constant_modes () const; + get_constant_modes () const override; protected: /* @@ -349,7 +349,7 @@ protected: get_data (const UpdateFlags /*update_flags*/, const Mapping<1,spacedim> &/*mapping*/, const Quadrature<1> &/*quadrature*/, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData<1, spacedim> &/*output_data*/) const + dealii::internal::FEValuesImplementation::FiniteElementRelatedData<1, spacedim> &/*output_data*/) const override { return std_cxx14::make_unique::InternalDataBase>(); } @@ -358,7 +358,7 @@ protected: get_face_data(const UpdateFlags update_flags, const Mapping<1,spacedim> &/*mapping*/, const Quadrature<0> &quadrature, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData<1, spacedim> &/*output_data*/) const + dealii::internal::FEValuesImplementation::FiniteElementRelatedData<1, spacedim> &/*output_data*/) const override { // generate a new data object and initialize some fields auto data = std_cxx14::make_unique::InternalDataBase>(); @@ -381,7 +381,7 @@ protected: get_subface_data(const UpdateFlags update_flags, const Mapping<1,spacedim> &mapping, const Quadrature<0> &quadrature, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData<1, spacedim> &output_data) const + dealii::internal::FEValuesImplementation::FiniteElementRelatedData<1, spacedim> &output_data) const override { return get_face_data(update_flags, mapping, quadrature, output_data); } @@ -395,7 +395,7 @@ protected: const typename Mapping<1,spacedim>::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData<1, spacedim> &mapping_data, const typename FiniteElement<1,spacedim>::InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData<1, spacedim> &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData<1, spacedim> &output_data) const override; virtual void @@ -406,7 +406,7 @@ protected: const typename Mapping<1,spacedim>::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData<1, spacedim> &mapping_data, const typename FiniteElement<1,spacedim>::InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData<1, spacedim> &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData<1, spacedim> &output_data) const override; virtual void @@ -418,7 +418,7 @@ protected: const typename Mapping<1,spacedim>::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData<1, spacedim> &mapping_data, const typename FiniteElement<1,spacedim>::InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData<1, spacedim> &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData<1, spacedim> &output_data) const override; private: /** @@ -468,14 +468,14 @@ public: virtual std::unique_ptr > - clone() const; + clone() const override; /** * Return a string that uniquely identifies a finite element. This class * returns FE_FaceP(degree) , with dim and * degree replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; /** * Return the matrix interpolating from a face of one element to the face @@ -487,7 +487,7 @@ public: */ virtual void get_face_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * Return the matrix interpolating from a face of one element to the face @@ -500,20 +500,20 @@ public: virtual void get_subface_interpolation_matrix (const FiniteElement &source, const unsigned int subface, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * This function returns @p true, if the shape function @p shape_index has * non-zero function values somewhere on the face @p face_index. */ virtual bool has_support_on_face (const unsigned int shape_index, - const unsigned int face_index) const; + const unsigned int face_index) const override; /** * Return whether this element implements its hanging node constraints in * the new way, which has to be used to make elements "hp compatible". */ - virtual bool hp_constraints_are_implemented () const; + virtual bool hp_constraints_are_implemented () const override; /** * Return whether this element dominates the one given as argument when they @@ -526,7 +526,7 @@ public: */ virtual FiniteElementDomination::Domination - compare_for_face_domination (const FiniteElement &fe_other) const; + compare_for_face_domination (const FiniteElement &fe_other) const override; /** * Return a list of constant modes of the element. For this element, the @@ -535,7 +535,7 @@ public: * polynomials). */ virtual std::pair, std::vector > - get_constant_modes () const; + get_constant_modes () const override; private: /** @@ -562,7 +562,7 @@ public: /** * Return the name of the element */ - std::string get_name() const; + std::string get_name() const override; }; diff --git a/include/deal.II/fe/fe_nedelec.h b/include/deal.II/fe/fe_nedelec.h index bcb33b9ef8..5a673094aa 100644 --- a/include/deal.II/fe/fe_nedelec.h +++ b/include/deal.II/fe/fe_nedelec.h @@ -124,7 +124,7 @@ public: * returns FE_Nedelec(degree), with @p dim and @p degree * replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; /** @@ -132,7 +132,7 @@ public: * non-zero function values somewhere on the face @p face_index. */ virtual bool has_support_on_face (const unsigned int shape_index, - const unsigned int face_index) const; + const unsigned int face_index) const override; /** * Return whether this element implements its hanging node constraints in @@ -142,14 +142,14 @@ public: * of the degree of the element), as it implements the complete set of * functions necessary for hp capability. */ - virtual bool hp_constraints_are_implemented () const; + virtual bool hp_constraints_are_implemented () const override; /** * Return whether this element dominates the one, which is given as * argument. */ virtual FiniteElementDomination::Domination - compare_for_face_domination (const FiniteElement &fe_other) const; + compare_for_face_domination (const FiniteElement &fe_other) const override; /** * If, on a vertex, several finite elements are active, the hp code first @@ -167,21 +167,21 @@ public: * corresponding index of the other finite element. */ virtual std::vector > - hp_vertex_dof_identities (const FiniteElement &fe_other) const; + hp_vertex_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees * of freedom on lines. */ virtual std::vector > - hp_line_dof_identities (const FiniteElement &fe_other) const; + hp_line_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees * of freedom on lines. */ virtual std::vector > - hp_quad_dof_identities (const FiniteElement &fe_other) const; + hp_quad_dof_identities (const FiniteElement &fe_other) const override; /** * Return the matrix interpolating from a face of one element to the face of @@ -196,7 +196,7 @@ public: */ virtual void get_face_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * Return the matrix interpolating from a face of one element to the subface @@ -212,7 +212,7 @@ public: virtual void get_subface_interpolation_matrix (const FiniteElement &source, const unsigned int subface, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * Projection from a fine grid space onto a coarse grid space. If this * projection operator is associated with a matrix @p P, then the @@ -229,7 +229,7 @@ public: */ virtual const FullMatrix & get_restriction_matrix (const unsigned int child, - const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const; + const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const override; /** * Embedding matrix between grids. @@ -253,25 +253,25 @@ public: */ virtual const FullMatrix & get_prolongation_matrix (const unsigned int child, - const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const; + const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const override; // documentation inherited from the base class virtual void convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + std::vector &nodal_values) const override; /** * Return a list of constant modes of the element. */ virtual std::pair, std::vector > - get_constant_modes () const; + get_constant_modes () const override; - virtual std::size_t memory_consumption () const; + virtual std::size_t memory_consumption () const override; virtual std::unique_ptr > - clone() const; + clone() const override; private: /** diff --git a/include/deal.II/fe/fe_nedelec_sz.h b/include/deal.II/fe/fe_nedelec_sz.h index 5575de3395..96a146d3ca 100644 --- a/include/deal.II/fe/fe_nedelec_sz.h +++ b/include/deal.II/fe/fe_nedelec_sz.h @@ -77,53 +77,53 @@ public: virtual UpdateFlags - requires_update_flags (const UpdateFlags update_flags) const; + requires_update_flags (const UpdateFlags update_flags) const override; - virtual std::string get_name () const; + virtual std::string get_name () const override; - virtual std::unique_ptr > clone() const; + virtual std::unique_ptr > clone() const override; /** * This element is vector-valued so this function will * throw an exception. */ virtual double shape_value (const unsigned int i, - const Point &p) const; + const Point &p) const override; /** * Not implemented. */ virtual double shape_value_component (const unsigned int i, const Point &p, - const unsigned int component) const; + const unsigned int component) const override; /** * This element is vector-valued so this function will * throw an exception. */ virtual Tensor<1,dim> shape_grad (const unsigned int i, - const Point &p) const; + const Point &p) const override; /** * Not implemented. */ virtual Tensor<1,dim> shape_grad_component (const unsigned int i, const Point &p, - const unsigned int component) const; + const unsigned int component) const override; /** * This element is vector-valued so this function will * throw an exception. */ virtual Tensor<2,dim> shape_grad_grad (const unsigned int i, - const Point &p) const; + const Point &p) const override; /** * Not implemented. */ virtual Tensor<2,dim> shape_grad_grad_component (const unsigned int i, const Point &p, - const unsigned int component) const; + const unsigned int component) const override; /** * Given flags, determines the values which must be computed only @@ -151,7 +151,7 @@ protected: get_data (const UpdateFlags update_flags, const Mapping &mapping, const Quadrature &quadrature, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; /** * Compute information about the shape functions on the cell denoted by the @@ -166,7 +166,7 @@ protected: const typename Mapping::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fedata, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &data) const override; /** * Compute information about the shape functions on the cell and face denoted @@ -181,7 +181,7 @@ protected: const typename Mapping::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fedata, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &data) const override; /** * Not implemented. @@ -195,7 +195,7 @@ protected: const typename Mapping::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fedata, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &data) const override; /** * Derived Internal data which is used to store cell-independent data. diff --git a/include/deal.II/fe/fe_p1nc.h b/include/deal.II/fe/fe_p1nc.h index a4c2cab161..c9a97f3925 100644 --- a/include/deal.II/fe/fe_p1nc.h +++ b/include/deal.II/fe/fe_p1nc.h @@ -261,18 +261,18 @@ public: */ FE_P1NC(); - virtual std::string get_name () const; + virtual std::string get_name () const override; - virtual UpdateFlags requires_update_flags (const UpdateFlags flags) const; + virtual UpdateFlags requires_update_flags (const UpdateFlags flags) const override; virtual std::unique_ptr> - clone() const; + clone() const override; /** * Destructor. */ - virtual ~FE_P1NC () = default; + virtual ~FE_P1NC () override = default; @@ -302,21 +302,21 @@ private: get_data (const UpdateFlags update_flags, const Mapping<2,2> &, const Quadrature<2> &quadrature, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData<2,2> &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData<2,2> &output_data) const override; virtual std::unique_ptr::InternalDataBase> get_face_data (const UpdateFlags update_flags, const Mapping<2,2> &, const Quadrature<1> &quadrature, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData<2,2> &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData<2,2> &output_data) const override; virtual std::unique_ptr::InternalDataBase> get_subface_data (const UpdateFlags update_flags, const Mapping<2,2> &, const Quadrature<1> &quadrature, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData<2,2> &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData<2,2> &output_data) const override; /** * Compute the data on the current cell. @@ -329,7 +329,7 @@ private: const Mapping<2,2>::InternalDataBase &mapping_internal, const internal::FEValuesImplementation::MappingRelatedData<2,2> &mapping_data, const FiniteElement<2,2>::InternalDataBase &fe_internal, - internal::FEValuesImplementation::FiniteElementRelatedData<2,2> &output_data) const; + internal::FEValuesImplementation::FiniteElementRelatedData<2,2> &output_data) const override; /** * Compute the data on the face of the current cell. @@ -342,7 +342,7 @@ private: const Mapping<2,2>::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData<2,2> &mapping_data, const InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData<2,2> &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData<2,2> &output_data) const override; /** * Compute the data on the subface of the current cell. @@ -356,7 +356,7 @@ private: const Mapping<2,2>::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData<2,2> &mapping_data, const InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData<2,2> &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData<2,2> &output_data) const override; /** * Create the constraints matrix for hanging edges. diff --git a/include/deal.II/fe/fe_poly.h b/include/deal.II/fe/fe_poly.h index d686d76e94..32fecaab19 100644 --- a/include/deal.II/fe/fe_poly.h +++ b/include/deal.II/fe/fe_poly.h @@ -86,7 +86,7 @@ public: // for documentation, see the FiniteElement base class virtual UpdateFlags - requires_update_flags (const UpdateFlags update_flags) const; + requires_update_flags (const UpdateFlags update_flags) const override; /** * Return the numbering of the underlying polynomial space compared to @@ -107,7 +107,7 @@ public: * the semantics of this function. */ virtual double shape_value (const unsigned int i, - const Point &p) const; + const Point &p) const override; /** * Return the value of the componentth vector component of the @@ -121,7 +121,7 @@ public: */ virtual double shape_value_component (const unsigned int i, const Point &p, - const unsigned int component) const; + const unsigned int component) const override; /** * Return the gradient of the ith shape function at the point @@ -129,7 +129,7 @@ public: * the semantics of this function. */ virtual Tensor<1,dim> shape_grad (const unsigned int i, - const Point &p) const; + const Point &p) const override; /** * Return the gradient of the componentth vector component of the @@ -143,7 +143,7 @@ public: */ virtual Tensor<1,dim> shape_grad_component (const unsigned int i, const Point &p, - const unsigned int component) const; + const unsigned int component) const override; /** * Return the tensor of second derivatives of the ith shape @@ -151,7 +151,7 @@ public: * class for more information about the semantics of this function. */ virtual Tensor<2,dim> shape_grad_grad (const unsigned int i, - const Point &p) const; + const Point &p) const override; /** * Return the second derivative of the componentth vector component @@ -165,7 +165,7 @@ public: */ virtual Tensor<2,dim> shape_grad_grad_component (const unsigned int i, const Point &p, - const unsigned int component) const; + const unsigned int component) const override; /** * Return the tensor of third derivatives of the ith shape function @@ -173,7 +173,7 @@ public: * for more information about the semantics of this function. */ virtual Tensor<3,dim> shape_3rd_derivative (const unsigned int i, - const Point &p) const; + const Point &p) const override; /** * Return the third derivative of the componentth vector component @@ -187,7 +187,7 @@ public: */ virtual Tensor<3,dim> shape_3rd_derivative_component (const unsigned int i, const Point &p, - const unsigned int component) const; + const unsigned int component) const override; /** * Return the tensor of fourth derivatives of the ith shape @@ -195,7 +195,7 @@ public: * class for more information about the semantics of this function. */ virtual Tensor<4,dim> shape_4th_derivative (const unsigned int i, - const Point &p) const; + const Point &p) const override; /** * Return the fourth derivative of the componentth vector component @@ -209,7 +209,7 @@ public: */ virtual Tensor<4,dim> shape_4th_derivative_component (const unsigned int i, const Point &p, - const unsigned int component) const; + const unsigned int component) const override; protected: /* @@ -223,7 +223,7 @@ protected: get_data(const UpdateFlags update_flags, const Mapping &/*mapping*/, const Quadrature &quadrature, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override { // generate a new data object and // initialize some fields @@ -334,7 +334,7 @@ protected: const typename Mapping::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; virtual void @@ -345,7 +345,7 @@ protected: const typename Mapping::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; virtual void @@ -357,7 +357,7 @@ protected: const typename Mapping::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; /** * Fields of cell-independent data. diff --git a/include/deal.II/fe/fe_poly_face.h b/include/deal.II/fe/fe_poly_face.h index 6f966822e8..14adae098b 100644 --- a/include/deal.II/fe/fe_poly_face.h +++ b/include/deal.II/fe/fe_poly_face.h @@ -72,7 +72,7 @@ public: // for documentation, see the FiniteElement base class virtual UpdateFlags - requires_update_flags (const UpdateFlags update_flags) const; + requires_update_flags (const UpdateFlags update_flags) const override; protected: /* @@ -86,7 +86,7 @@ protected: get_data (const UpdateFlags /*update_flags*/, const Mapping &/*mapping*/, const Quadrature &/*quadrature*/, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &/*output_data*/) const + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &/*output_data*/) const override { return std_cxx14::make_unique(); } @@ -95,7 +95,7 @@ protected: get_face_data(const UpdateFlags update_flags, const Mapping &/*mapping*/, const Quadrature &quadrature, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &/*output_data*/) const + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &/*output_data*/) const override { // generate a new data object and // initialize some fields @@ -144,7 +144,7 @@ protected: get_subface_data(const UpdateFlags update_flags, const Mapping &mapping, const Quadrature &quadrature, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override { return get_face_data(update_flags, mapping, QProjector::project_to_all_children(quadrature), @@ -160,7 +160,7 @@ protected: const typename Mapping::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; virtual void @@ -171,7 +171,7 @@ protected: const typename Mapping::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; virtual void @@ -183,7 +183,7 @@ protected: const typename Mapping::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; /** * Fields of cell-independent data. diff --git a/include/deal.II/fe/fe_poly_tensor.h b/include/deal.II/fe/fe_poly_tensor.h index eb0ef5af00..cd5c2cb595 100644 --- a/include/deal.II/fe/fe_poly_tensor.h +++ b/include/deal.II/fe/fe_poly_tensor.h @@ -154,7 +154,7 @@ public: // for documentation, see the FiniteElement base class virtual UpdateFlags - requires_update_flags (const UpdateFlags update_flags) const; + requires_update_flags (const UpdateFlags update_flags) const override; /** * Compute the (scalar) value of shape function @p i at the given quadrature @@ -163,12 +163,12 @@ public: * an exception. */ virtual double shape_value (const unsigned int i, - const Point &p) const; + const Point &p) const override; // documentation inherited from the base class virtual double shape_value_component (const unsigned int i, const Point &p, - const unsigned int component) const; + const unsigned int component) const override; /** * Compute the gradient of (scalar) shape function @p i at the given @@ -177,12 +177,12 @@ public: * throws an exception. */ virtual Tensor<1,dim> shape_grad (const unsigned int i, - const Point &p) const; + const Point &p) const override; // documentation inherited from the base class virtual Tensor<1,dim> shape_grad_component (const unsigned int i, const Point &p, - const unsigned int component) const; + const unsigned int component) const override; /** * Compute the Hessian of (scalar) shape function @p i at the given @@ -191,12 +191,12 @@ public: * throws an exception. */ virtual Tensor<2,dim> shape_grad_grad (const unsigned int i, - const Point &p) const; + const Point &p) const override; // documentation inherited from the base class virtual Tensor<2,dim> shape_grad_grad_component (const unsigned int i, const Point &p, - const unsigned int component) const; + const unsigned int component) const override; protected: /** @@ -213,7 +213,7 @@ protected: get_data(const UpdateFlags update_flags, const Mapping &/*mapping*/, const Quadrature &quadrature, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &/*output_data*/) const + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &/*output_data*/) const override { // generate a new data object and // initialize some fields @@ -341,7 +341,7 @@ protected: const typename Mapping::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; virtual void @@ -352,7 +352,7 @@ protected: const typename Mapping::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; virtual void @@ -364,7 +364,7 @@ protected: const typename Mapping::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; /** * Fields of cell-independent data for FE_PolyTensor. Stores the values of diff --git a/include/deal.II/fe/fe_q.h b/include/deal.II/fe/fe_q.h index d55171425f..fbfe93e5f6 100644 --- a/include/deal.II/fe/fe_q.h +++ b/include/deal.II/fe/fe_q.h @@ -576,11 +576,11 @@ public: * returns FE_Q(degree), with @p dim and @p degree replaced by * appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; virtual std::unique_ptr > - clone() const; + clone() const override; /** * Implementation of the corresponding function in the FiniteElement @@ -592,7 +592,7 @@ public: virtual void convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + std::vector &nodal_values) const override; }; diff --git a/include/deal.II/fe/fe_q_base.h b/include/deal.II/fe/fe_q_base.h index 7d719cda1d..474b4a5416 100644 --- a/include/deal.II/fe/fe_q_base.h +++ b/include/deal.II/fe/fe_q_base.h @@ -58,7 +58,7 @@ public: */ virtual void get_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** @@ -72,7 +72,7 @@ public: */ virtual void get_face_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * Return the matrix interpolating from a face of one element to the face @@ -86,14 +86,14 @@ public: virtual void get_subface_interpolation_matrix (const FiniteElement &source, const unsigned int subface, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * This function returns @p true, if the shape function @p shape_index has * non-zero function values somewhere on the face @p face_index. */ virtual bool has_support_on_face (const unsigned int shape_index, - const unsigned int face_index) const; + const unsigned int face_index) const override; /** * Projection from a fine grid space onto a coarse grid space. Overrides the @@ -119,7 +119,7 @@ public: */ virtual const FullMatrix & get_restriction_matrix (const unsigned int child, - const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const; + const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const override; /** * Embedding matrix between grids. Overrides the respective method in @@ -149,7 +149,7 @@ public: */ virtual const FullMatrix & get_prolongation_matrix (const unsigned int child, - const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const; + const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const override; /** * Given an index in the natural ordering of indices on a face, return the @@ -194,14 +194,14 @@ public: const unsigned int face, const bool face_orientation = true, const bool face_flip = false, - const bool face_rotation = false) const; + const bool face_rotation = false) const override; /** * Return a list of constant modes of the element. For this element, the * list consists of true arguments for all components. */ virtual std::pair, std::vector > - get_constant_modes () const; + get_constant_modes () const override; /** * @name Functions to support hp @@ -216,7 +216,7 @@ public: * of the element), as it implements the complete set of functions necessary * for hp capability. */ - virtual bool hp_constraints_are_implemented () const; + virtual bool hp_constraints_are_implemented () const override; /** * If, on a vertex, several finite elements are active, the hp code first @@ -235,7 +235,7 @@ public: */ virtual std::vector > - hp_vertex_dof_identities (const FiniteElement &fe_other) const; + hp_vertex_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -243,7 +243,7 @@ public: */ virtual std::vector > - hp_line_dof_identities (const FiniteElement &fe_other) const; + hp_line_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -251,7 +251,7 @@ public: */ virtual std::vector > - hp_quad_dof_identities (const FiniteElement &fe_other) const; + hp_quad_dof_identities (const FiniteElement &fe_other) const override; /** * Return whether this element dominates the one given as argument when they @@ -264,7 +264,7 @@ public: */ virtual FiniteElementDomination::Domination - compare_for_face_domination (const FiniteElement &fe_other) const; + compare_for_face_domination (const FiniteElement &fe_other) const override; //@} /** diff --git a/include/deal.II/fe/fe_q_bubbles.h b/include/deal.II/fe/fe_q_bubbles.h index 25af8f5f14..b3ac403142 100644 --- a/include/deal.II/fe/fe_q_bubbles.h +++ b/include/deal.II/fe/fe_q_bubbles.h @@ -102,13 +102,13 @@ public: * returns FE_Q_Bubbles(degree), with @p dim and @p degree * replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; // documentation inherited from the base class virtual void convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + std::vector &nodal_values) const override; /** * Return the matrix interpolating from the given finite element to the @@ -121,15 +121,15 @@ public: */ virtual void get_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; virtual const FullMatrix & get_prolongation_matrix (const unsigned int child, - const RefinementCase &refinement_case) const; + const RefinementCase &refinement_case) const override; virtual const FullMatrix & get_restriction_matrix (const unsigned int child, - const RefinementCase &refinement_case) const; + const RefinementCase &refinement_case) const override; /** * Check for non-zero values on a face. @@ -140,11 +140,11 @@ public: * Implementation of the interface in FiniteElement */ virtual bool has_support_on_face (const unsigned int shape_index, - const unsigned int face_index) const; + const unsigned int face_index) const override; virtual std::unique_ptr > - clone() const; + clone() const override; private: diff --git a/include/deal.II/fe/fe_q_dg0.h b/include/deal.II/fe/fe_q_dg0.h index 00c75b00d9..d2215f74b6 100644 --- a/include/deal.II/fe/fe_q_dg0.h +++ b/include/deal.II/fe/fe_q_dg0.h @@ -256,13 +256,13 @@ public: * returns FE_Q_DG0(degree), with @p dim and @p degree * replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; // documentation inherited from the base class virtual void convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + std::vector &nodal_values) const override; /** * Return the matrix interpolating from the given finite element to the @@ -275,7 +275,7 @@ public: */ virtual void get_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** @@ -283,7 +283,7 @@ public: * non-zero function values somewhere on the face @p face_index. */ virtual bool has_support_on_face (const unsigned int shape_index, - const unsigned int face_index) const; + const unsigned int face_index) const override; /** * Return a list of constant modes of the element. For this element, there @@ -292,11 +292,11 @@ public: * the discontinuous part. */ virtual std::pair, std::vector > - get_constant_modes () const; + get_constant_modes () const override; virtual std::unique_ptr > - clone() const; + clone() const override; private: diff --git a/include/deal.II/fe/fe_q_hierarchical.h b/include/deal.II/fe/fe_q_hierarchical.h index bb900c62ed..5d88fd9860 100644 --- a/include/deal.II/fe/fe_q_hierarchical.h +++ b/include/deal.II/fe/fe_q_hierarchical.h @@ -551,18 +551,18 @@ public: * returns FE_Q_Hierarchical(degree), with @p dim and @p * degree replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; virtual std::unique_ptr > - clone() const; + clone() const override; /** * This function returns @p true, if the shape function @p shape_index has * non-zero function values somewhere on the face @p face_index. */ virtual bool has_support_on_face (const unsigned int shape_index, - const unsigned int face_index) const; + const unsigned int face_index) const override; /** * @name Functions to support hp @@ -577,21 +577,21 @@ public: * the degree of the element), as it implements the complete set of * functions necessary for hp capability. */ - virtual bool hp_constraints_are_implemented () const; + virtual bool hp_constraints_are_implemented () const override; /** * Return the matrix interpolating from the given finite element to the * present one. Interpolation only between FE_Q_Hierarchical is supported. */ virtual void get_interpolation_matrix(const FiniteElement< dim> &source, - FullMatrix< double > &matrix) const; + FullMatrix< double > &matrix) const override; /** * Embedding matrix between grids. Only isotropic refinement is supported. */ virtual const FullMatrix &get_prolongation_matrix (const unsigned int child, - const RefinementCase &refinement_case = RefinementCase< dim >::isotropic_refinement) const; + const RefinementCase &refinement_case = RefinementCase< dim >::isotropic_refinement) const override; /** * If, on a vertex, several finite elements are active, the hp code first @@ -610,21 +610,21 @@ public: */ virtual std::vector > - hp_vertex_dof_identities (const FiniteElement &fe_other) const; + hp_vertex_dof_identities (const FiniteElement &fe_other) const override; /** * Same as above but for lines. */ virtual std::vector > - hp_line_dof_identities (const FiniteElement &fe_other) const; + hp_line_dof_identities (const FiniteElement &fe_other) const override; /** * Same as above but for faces. */ virtual std::vector > - hp_quad_dof_identities (const FiniteElement &fe_other) const; + hp_quad_dof_identities (const FiniteElement &fe_other) const override; /*@}*/ @@ -639,7 +639,7 @@ public: * from a given element, then they must throw an exception of type * FiniteElement::ExcInterpolationNotImplemented. */ - virtual void get_face_interpolation_matrix (const FiniteElement &source, FullMatrix &matrix) const; + virtual void get_face_interpolation_matrix (const FiniteElement &source, FullMatrix &matrix) const override; /** * Return the matrix interpolating from a face of one element to the subface @@ -652,7 +652,7 @@ public: * from a given element, then they must throw an exception of type * ExcInterpolationNotImplemented. */ - virtual void get_subface_interpolation_matrix (const FiniteElement &source, const unsigned int subface, FullMatrix &matrix) const; + virtual void get_subface_interpolation_matrix (const FiniteElement &source, const unsigned int subface, FullMatrix &matrix) const override; /** * Return whether this element dominates the one given as argument when they @@ -665,7 +665,7 @@ public: */ virtual FiniteElementDomination::Domination - compare_for_face_domination (const FiniteElement &fe_other) const; + compare_for_face_domination (const FiniteElement &fe_other) const override; /** * Determine an estimate for the memory consumption (in bytes) of this @@ -675,7 +675,7 @@ public: * accessed through pointers to their base class, rather than the class * itself. */ - virtual std::size_t memory_consumption () const; + virtual std::size_t memory_consumption () const override; /** * For a finite element of degree @p sub_degree < @p degree, we return a @@ -690,7 +690,7 @@ public: * false for the remaining ones. */ virtual std::pair, std::vector > - get_constant_modes () const; + get_constant_modes () const override; private: diff --git a/include/deal.II/fe/fe_q_iso_q1.h b/include/deal.II/fe/fe_q_iso_q1.h index 158ebd26a9..32744ae27f 100644 --- a/include/deal.II/fe/fe_q_iso_q1.h +++ b/include/deal.II/fe/fe_q_iso_q1.h @@ -123,11 +123,11 @@ public: * returns FE_Q_iso_q1(equivalent_degree), with @p dim and @p * equivalent_degree replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; virtual std::unique_ptr > - clone() const; + clone() const override; /** * Implementation of the corresponding function in the FiniteElement @@ -139,7 +139,7 @@ public: virtual void convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + std::vector &nodal_values) const override; /** * @name Functions to support hp @@ -157,7 +157,7 @@ public: */ virtual FiniteElementDomination::Domination - compare_for_face_domination (const FiniteElement &fe_other) const; + compare_for_face_domination (const FiniteElement &fe_other) const override; //@} }; diff --git a/include/deal.II/fe/fe_rannacher_turek.h b/include/deal.II/fe/fe_rannacher_turek.h index d903cea1c8..20880f20a5 100644 --- a/include/deal.II/fe/fe_rannacher_turek.h +++ b/include/deal.II/fe/fe_rannacher_turek.h @@ -64,17 +64,17 @@ public: FE_RannacherTurek(const unsigned int order = 0, const unsigned int n_face_support_points = 2); - virtual std::string get_name() const; + virtual std::string get_name() const override; virtual std::unique_ptr > - clone() const; + clone() const override; // documentation inherited from the base class virtual void convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + std::vector &nodal_values) const override; private: /** diff --git a/include/deal.II/fe/fe_raviart_thomas.h b/include/deal.II/fe/fe_raviart_thomas.h index a496f05e29..a7b0896c25 100644 --- a/include/deal.II/fe/fe_raviart_thomas.h +++ b/include/deal.II/fe/fe_raviart_thomas.h @@ -115,12 +115,12 @@ public: * returns FE_RaviartThomas(degree), with @p dim and @p degree * replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; // documentation inherited from the base class virtual std::unique_ptr > - clone() const; + clone() const override; /** * This function returns @p true, if the shape function @p shape_index has @@ -130,22 +130,22 @@ public: * always @p true. */ virtual bool has_support_on_face (const unsigned int shape_index, - const unsigned int face_index) const; + const unsigned int face_index) const override; // documentation inherited from the base class virtual void convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + std::vector &nodal_values) const override; /** * Return a list of constant modes of the element. This method is currently * not correctly implemented because it returns ones for all components. */ virtual std::pair, std::vector > - get_constant_modes () const; + get_constant_modes () const override; - virtual std::size_t memory_consumption () const; + virtual std::size_t memory_consumption () const override; private: /** @@ -255,37 +255,37 @@ public: * returns FE_RaviartThomasNodal(degree), with @p dim and @p * degree replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; // documentation inherited from the base class virtual std::unique_ptr > - clone() const; + clone() const override; virtual void convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + std::vector &nodal_values) const override; virtual void get_face_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; virtual void get_subface_interpolation_matrix (const FiniteElement &source, const unsigned int subface, - FullMatrix &matrix) const; - virtual bool hp_constraints_are_implemented () const; + FullMatrix &matrix) const override; + virtual bool hp_constraints_are_implemented () const override; virtual std::vector > - hp_vertex_dof_identities (const FiniteElement &fe_other) const; + hp_vertex_dof_identities (const FiniteElement &fe_other) const override; virtual std::vector > - hp_line_dof_identities (const FiniteElement &fe_other) const; + hp_line_dof_identities (const FiniteElement &fe_other) const override; virtual std::vector > - hp_quad_dof_identities (const FiniteElement &fe_other) const; + hp_quad_dof_identities (const FiniteElement &fe_other) const override; virtual FiniteElementDomination::Domination - compare_for_face_domination (const FiniteElement &fe_other) const; + compare_for_face_domination (const FiniteElement &fe_other) const override; private: /** @@ -312,7 +312,7 @@ private: * always @p true. */ virtual bool has_support_on_face (const unsigned int shape_index, - const unsigned int face_index) const; + const unsigned int face_index) const override; /** * Initialize the FiniteElement::generalized_support_points and * FiniteElement::generalized_face_support_points fields. Called from diff --git a/include/deal.II/fe/fe_system.h b/include/deal.II/fe/fe_system.h index db753852f4..a9b4bba676 100644 --- a/include/deal.II/fe/fe_system.h +++ b/include/deal.II/fe/fe_system.h @@ -497,7 +497,7 @@ public: /** * Destructor. */ - virtual ~FESystem () = default; + virtual ~FESystem () override = default; /** * Return a string that uniquely identifies a finite element. This element @@ -507,15 +507,15 @@ public: * the multiplicities of the basis elements. If a multiplicity is equal to * one, then the superscript is omitted. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; virtual std::unique_ptr > - clone() const; + clone() const override; virtual UpdateFlags - requires_update_flags (const UpdateFlags update_flags) const; + requires_update_flags (const UpdateFlags update_flags) const override; // make variant with ComponentMask also available: using FiniteElement::get_sub_fe; @@ -526,7 +526,7 @@ public: virtual const FiniteElement & get_sub_fe (const unsigned int first_component, - const unsigned int n_selected_components) const; + const unsigned int n_selected_components) const override; /** * Return the value of the @p ith shape function at the point @p p. @p p is @@ -541,7 +541,7 @@ public: * the shape of the cell in real space. */ virtual double shape_value (const unsigned int i, - const Point &p) const; + const Point &p) const override; /** * Return the value of the @p componentth vector component of the @p ith @@ -553,7 +553,7 @@ public: */ virtual double shape_value_component (const unsigned int i, const Point &p, - const unsigned int component) const; + const unsigned int component) const override; /** * Return the gradient of the @p ith shape function at the point @p p. @p p @@ -570,7 +570,7 @@ public: * the shape of the cell in real space. */ virtual Tensor<1,dim> shape_grad (const unsigned int i, - const Point &p) const; + const Point &p) const override; /** * Return the gradient of the @p componentth vector component of the @p ith @@ -582,7 +582,7 @@ public: */ virtual Tensor<1,dim> shape_grad_component (const unsigned int i, const Point &p, - const unsigned int component) const; + const unsigned int component) const override; /** * Return the tensor of second derivatives of the @p ith shape function at @@ -599,7 +599,7 @@ public: * the shape of the cell in real space. */ virtual Tensor<2,dim> shape_grad_grad (const unsigned int i, - const Point &p) const; + const Point &p) const override; /** * Return the second derivatives of the @p componentth vector component of @@ -613,7 +613,7 @@ public: Tensor<2,dim> shape_grad_grad_component (const unsigned int i, const Point &p, - const unsigned int component) const; + const unsigned int component) const override; /** * Return the tensor of third derivatives of the @p ith shape function at @@ -630,7 +630,7 @@ public: * the shape of the cell in real space. */ virtual Tensor<3,dim> shape_3rd_derivative (const unsigned int i, - const Point &p) const; + const Point &p) const override; /** * Return the third derivatives of the @p componentth vector component of @@ -642,7 +642,7 @@ public: */ virtual Tensor<3,dim> shape_3rd_derivative_component (const unsigned int i, const Point &p, - const unsigned int component) const; + const unsigned int component) const override; /** * Return the tensor of fourth derivatives of the @p ith shape function at @@ -659,7 +659,7 @@ public: * the shape of the cell in real space. */ virtual Tensor<4,dim> shape_4th_derivative (const unsigned int i, - const Point &p) const; + const Point &p) const override; /** * Return the fourth derivatives of the @p componentth vector component of @@ -671,7 +671,7 @@ public: */ virtual Tensor<4,dim> shape_4th_derivative_component (const unsigned int i, const Point &p, - const unsigned int component) const; + const unsigned int component) const override; /** * Return the matrix interpolating from the given finite element to the @@ -686,7 +686,7 @@ public: */ virtual void get_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * Access to a composing element. The index needs to be smaller than the @@ -695,14 +695,14 @@ public: * the multiplicities are greater than one. */ virtual const FiniteElement & - base_element (const unsigned int index) const; + base_element (const unsigned int index) const override; /** * This function returns @p true, if the shape function @p shape_index has * non-zero function values somewhere on the face @p face_index. */ virtual bool has_support_on_face (const unsigned int shape_index, - const unsigned int face_index) const; + const unsigned int face_index) const override; /** * Projection from a fine grid space onto a coarse grid space. Overrides the @@ -729,7 +729,7 @@ public: */ virtual const FullMatrix & get_restriction_matrix (const unsigned int child, - const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const; + const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const override; /** * Embedding matrix between grids. Overrides the respective method in @@ -760,7 +760,7 @@ public: */ virtual const FullMatrix & get_prolongation_matrix (const unsigned int child, - const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const; + const RefinementCase &refinement_case=RefinementCase::isotropic_refinement) const override; /** * Given an index in the natural ordering of indices on a face, return the @@ -805,21 +805,21 @@ public: const unsigned int face, const bool face_orientation = true, const bool face_flip = false, - const bool face_rotation = false) const; + const bool face_rotation = false) const override; /** * Implementation of the respective function in the base class. */ virtual Point - unit_support_point (const unsigned int index) const; + unit_support_point (const unsigned int index) const override; /** * Implementation of the respective function in the base class. */ virtual Point - unit_face_support_point (const unsigned int index) const; + unit_face_support_point (const unsigned int index) const override; /** * Return a list of constant modes of the element. The returns table has as @@ -829,7 +829,7 @@ public: * element. Concatenates the constant modes of each base element. */ virtual std::pair, std::vector > - get_constant_modes () const; + get_constant_modes () const override; /** * @name Functions to support hp @@ -843,7 +843,7 @@ public: * This function returns @p true if and only if all its base elements return * @p true for this function. */ - virtual bool hp_constraints_are_implemented () const; + virtual bool hp_constraints_are_implemented () const override; /** * Return the matrix interpolating from a face of one element to the face @@ -859,7 +859,7 @@ public: */ virtual void get_face_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** @@ -877,7 +877,7 @@ public: virtual void get_subface_interpolation_matrix (const FiniteElement &source, const unsigned int subface, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * If, on a vertex, several finite elements are active, the hp code first @@ -896,7 +896,7 @@ public: */ virtual std::vector > - hp_vertex_dof_identities (const FiniteElement &fe_other) const; + hp_vertex_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -904,7 +904,7 @@ public: */ virtual std::vector > - hp_line_dof_identities (const FiniteElement &fe_other) const; + hp_line_dof_identities (const FiniteElement &fe_other) const override; /** * Same as hp_vertex_dof_indices(), except that the function treats degrees @@ -912,7 +912,7 @@ public: */ virtual std::vector > - hp_quad_dof_identities (const FiniteElement &fe_other) const; + hp_quad_dof_identities (const FiniteElement &fe_other) const override; /** * Return whether this element dominates the one given as argument when they @@ -925,7 +925,7 @@ public: */ virtual FiniteElementDomination::Domination - compare_for_face_domination (const FiniteElement &fe_other) const; + compare_for_face_domination (const FiniteElement &fe_other) const override; //@} /** @@ -945,7 +945,7 @@ public: virtual void convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, - std::vector &dof_values) const; + std::vector &dof_values) const override; /** * Determine an estimate for the memory consumption (in bytes) of this @@ -955,7 +955,7 @@ public: * accessed through pointers to their base class, rather than the class * itself. */ - virtual std::size_t memory_consumption () const; + virtual std::size_t memory_consumption () const override; protected: @@ -964,21 +964,21 @@ protected: get_data (const UpdateFlags update_flags, const Mapping &mapping, const Quadrature &quadrature, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; virtual std::unique_ptr::InternalDataBase> get_face_data (const UpdateFlags update_flags, const Mapping &mapping, const Quadrature &quadrature, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; virtual std::unique_ptr::InternalDataBase> get_subface_data (const UpdateFlags update_flags, const Mapping &mapping, const Quadrature &quadrature, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; virtual void @@ -989,7 +989,7 @@ protected: const typename Mapping::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; virtual void @@ -1000,7 +1000,7 @@ protected: const typename Mapping::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; virtual void @@ -1012,7 +1012,7 @@ protected: const typename Mapping::InternalDataBase &mapping_internal, const dealii::internal::FEValuesImplementation::MappingRelatedData &mapping_data, const typename FiniteElement::InternalDataBase &fe_internal, - dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const; + dealii::internal::FEValuesImplementation::FiniteElementRelatedData &output_data) const override; /** * Do the work for the three fill_fe*_values functions. @@ -1109,7 +1109,7 @@ private: * Destructor. Deletes all @p InternalDatas whose pointers are stored by * the @p base_fe_datas vector. */ - ~InternalData(); + ~InternalData() override; /** * Give write-access to the pointer to a @p InternalData of the @p diff --git a/include/deal.II/fe/fe_tools.h b/include/deal.II/fe/fe_tools.h index f316113b0f..1fac784b7d 100644 --- a/include/deal.II/fe/fe_tools.h +++ b/include/deal.II/fe/fe_tools.h @@ -98,7 +98,7 @@ namespace FETools /** * Virtual destructor doing nothing but making the compiler happy. */ - virtual ~FEFactoryBase() = default; + virtual ~FEFactoryBase() override = default; }; /** @@ -120,14 +120,14 @@ namespace FETools * Create a FiniteElement and return a pointer to it. */ virtual std::unique_ptr > - get (const unsigned int degree) const; + get (const unsigned int degree) const override; /** * Create a FiniteElement from a quadrature formula (currently only * implemented for FE_Q) and return a pointer to it. */ virtual std::unique_ptr > - get (const Quadrature<1> &quad) const; + get (const Quadrature<1> &quad) const override; }; /** diff --git a/include/deal.II/fe/fe_trace.h b/include/deal.II/fe/fe_trace.h index fd42d03787..ab61f2f777 100644 --- a/include/deal.II/fe/fe_trace.h +++ b/include/deal.II/fe/fe_trace.h @@ -56,11 +56,11 @@ public: * returns FE_DGQ(degree), with dim and * degree replaced by appropriate values. */ - virtual std::string get_name () const; + virtual std::string get_name () const override; virtual std::unique_ptr > - clone() const; + clone() const override; /** * Implementation of the corresponding function in the FiniteElement @@ -72,27 +72,27 @@ public: virtual void convert_generalized_support_point_values_to_dof_values (const std::vector > &support_point_values, - std::vector &nodal_values) const; + std::vector &nodal_values) const override; /** * This function returns @p true, if the shape function @p shape_index has * non-zero function values somewhere on the face @p face_index. */ virtual bool has_support_on_face (const unsigned int shape_index, - const unsigned int face_index) const; + const unsigned int face_index) const override; /** * Return a list of constant modes of the element. For this element, it * simply returns one row with all entries set to true. */ virtual std::pair, std::vector > - get_constant_modes () const; + get_constant_modes () const override; /** * Return whether this element implements its hanging node constraints in * the new way, which has to be used to make elements "hp compatible". */ - virtual bool hp_constraints_are_implemented () const; + virtual bool hp_constraints_are_implemented () const override; /** * Return the matrix interpolating from a face of one element to the face @@ -104,7 +104,7 @@ public: */ virtual void get_face_interpolation_matrix (const FiniteElement &source, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * Return the matrix interpolating from a face of one element to the face @@ -117,7 +117,7 @@ public: virtual void get_subface_interpolation_matrix (const FiniteElement &source, const unsigned int subface, - FullMatrix &matrix) const; + FullMatrix &matrix) const override; /** * Return whether this element dominates the one given as argument when they @@ -130,7 +130,7 @@ public: */ virtual FiniteElementDomination::Domination - compare_for_face_domination (const FiniteElement &fe_other) const; + compare_for_face_domination (const FiniteElement &fe_other) const override; private: /** @@ -161,7 +161,7 @@ public: /** * Return the name of the element */ - std::string get_name() const; + std::string get_name() const override; }; diff --git a/include/deal.II/fe/fe_values.h b/include/deal.II/fe/fe_values.h index 3ec07ee051..d38072c499 100644 --- a/include/deal.II/fe/fe_values.h +++ b/include/deal.II/fe/fe_values.h @@ -1864,7 +1864,7 @@ public: /** * Destructor. */ - ~FEValuesBase (); + ~FEValuesBase () override; /// @name ShapeAccess Access to shape function values. These fields are filled by the finite element. diff --git a/include/deal.II/grid/grid_tools_cache.h b/include/deal.II/grid/grid_tools_cache.h index c0e86ce790..d03c3ead77 100644 --- a/include/deal.II/grid/grid_tools_cache.h +++ b/include/deal.II/grid/grid_tools_cache.h @@ -81,7 +81,7 @@ namespace GridTools /** * Destructor. */ - ~Cache(); + ~Cache() override; /** * Make sure that the objects marked for update are recomputed during diff --git a/include/deal.II/grid/manifold.h b/include/deal.II/grid/manifold.h index 8fb117cd88..d4f97a83a1 100644 --- a/include/deal.II/grid/manifold.h +++ b/include/deal.II/grid/manifold.h @@ -348,7 +348,7 @@ public: * Destructor. Does nothing here, but needs to be declared virtual to make * class hierarchies derived from this class possible. */ - virtual ~Manifold () = default; + virtual ~Manifold () override = default; /** * Return a copy of this manifold. diff --git a/include/deal.II/grid/persistent_tria.h b/include/deal.II/grid/persistent_tria.h index 3bf1c4653a..5a6794b354 100644 --- a/include/deal.II/grid/persistent_tria.h +++ b/include/deal.II/grid/persistent_tria.h @@ -133,7 +133,7 @@ public: /** * Destructor. */ - virtual ~PersistentTriangulation () = default; + virtual ~PersistentTriangulation () override = default; /** * Overloaded version of the same function in the base class which stores @@ -141,7 +141,7 @@ public: * triangulation and after that calls the respective function of the base * class. */ - virtual void execute_coarsening_and_refinement (); + virtual void execute_coarsening_and_refinement () override; /** * Restore the grid according to the saved data. For this, the coarse grid @@ -182,7 +182,7 @@ public: * The coarse grid must persist until the end of this object, since it will * be used upon reconstruction of the grid. */ - virtual void copy_triangulation (const Triangulation &tria); + virtual void copy_triangulation (const Triangulation &tria) override; /** * Throw an error, since this function is not useful in the context of this @@ -190,7 +190,7 @@ public: */ virtual void create_triangulation (const std::vector > &vertices, const std::vector > &cells, - const SubCellData &subcelldata); + const SubCellData &subcelldata) override; /** * An overload of the respective function of the base class. @@ -201,7 +201,7 @@ public: virtual void create_triangulation_compatibility ( const std::vector > &vertices, const std::vector > &cells, - const SubCellData &subcelldata); + const SubCellData &subcelldata) override; /** * Write all refine and coarsen flags to the ostream @p out. @@ -224,7 +224,7 @@ public: * Determine an estimate for the memory consumption (in bytes) of this * object. */ - virtual std::size_t memory_consumption () const; + virtual std::size_t memory_consumption () const override; /** * Exception. diff --git a/include/deal.II/grid/tria.h b/include/deal.II/grid/tria.h index db10e2875a..7ea247c605 100644 --- a/include/deal.II/grid/tria.h +++ b/include/deal.II/grid/tria.h @@ -1613,7 +1613,7 @@ public: * automatically generated destructor would have a different one due to * member objects. */ - virtual ~DistortedCellList () noexcept; + virtual ~DistortedCellList () noexcept override; /** * A list of those cells among the coarse mesh cells that are deformed or @@ -1683,7 +1683,7 @@ public: /** * Delete the object and all levels of the hierarchy. */ - virtual ~Triangulation (); + virtual ~Triangulation () override; /** * Reset this triangulation into a virgin state by deleting all data. diff --git a/include/deal.II/hp/dof_handler.h b/include/deal.II/hp/dof_handler.h index 403e414be4..42ab2d8e26 100644 --- a/include/deal.II/hp/dof_handler.h +++ b/include/deal.II/hp/dof_handler.h @@ -275,7 +275,7 @@ namespace hp /** * Destructor. */ - virtual ~DoFHandler (); + virtual ~DoFHandler () override; /** * Copy operator. DoFHandler objects are large and expensive. diff --git a/include/deal.II/lac/block_matrix_base.h b/include/deal.II/lac/block_matrix_base.h index 73c0739fc5..31ec568210 100644 --- a/include/deal.II/lac/block_matrix_base.h +++ b/include/deal.II/lac/block_matrix_base.h @@ -375,7 +375,7 @@ public: /** * Destructor. */ - ~BlockMatrixBase (); + ~BlockMatrixBase () override; /** * Copy the matrix given as argument into the current object. diff --git a/include/deal.II/lac/block_sparse_matrix.h b/include/deal.II/lac/block_sparse_matrix.h index 23ec065cc8..6e2ddacb2d 100644 --- a/include/deal.II/lac/block_sparse_matrix.h +++ b/include/deal.II/lac/block_sparse_matrix.h @@ -106,7 +106,7 @@ public: /** * Destructor. */ - virtual ~BlockSparseMatrix (); + virtual ~BlockSparseMatrix () override; diff --git a/include/deal.II/lac/block_sparsity_pattern.h b/include/deal.II/lac/block_sparsity_pattern.h index e1eea163be..8d54e931ad 100644 --- a/include/deal.II/lac/block_sparsity_pattern.h +++ b/include/deal.II/lac/block_sparsity_pattern.h @@ -115,7 +115,7 @@ public: /** * Destructor. */ - ~BlockSparsityPatternBase (); + ~BlockSparsityPatternBase () override; /** * Resize the matrix, by setting the number of block rows and columns. This diff --git a/include/deal.II/lac/block_vector.h b/include/deal.II/lac/block_vector.h index 529820c09f..08dff12c57 100644 --- a/include/deal.II/lac/block_vector.h +++ b/include/deal.II/lac/block_vector.h @@ -168,7 +168,7 @@ public: /** * Destructor. Clears memory */ - ~BlockVector () = default; + ~BlockVector () override = default; /** * Call the compress() function on all the subblocks. diff --git a/include/deal.II/lac/chunk_sparse_matrix.h b/include/deal.II/lac/chunk_sparse_matrix.h index 7fdc95d071..56f9cc4239 100644 --- a/include/deal.II/lac/chunk_sparse_matrix.h +++ b/include/deal.II/lac/chunk_sparse_matrix.h @@ -516,7 +516,7 @@ public: * Destructor. Free all memory, but do not release the memory of the * sparsity structure. */ - virtual ~ChunkSparseMatrix (); + virtual ~ChunkSparseMatrix () override; /** * Copy operator. Since copying entire sparse matrices is a very expensive diff --git a/include/deal.II/lac/chunk_sparsity_pattern.h b/include/deal.II/lac/chunk_sparsity_pattern.h index 0113a46d54..869aa3a4bc 100644 --- a/include/deal.II/lac/chunk_sparsity_pattern.h +++ b/include/deal.II/lac/chunk_sparsity_pattern.h @@ -334,7 +334,7 @@ public: /** * Destructor. */ - ~ChunkSparsityPattern () = default; + ~ChunkSparsityPattern () override = default; /** * Copy operator. For this the same holds as for the copy constructor: it is diff --git a/include/deal.II/lac/exceptions.h b/include/deal.II/lac/exceptions.h index 453fbe5a9b..6fee61e5c2 100644 --- a/include/deal.II/lac/exceptions.h +++ b/include/deal.II/lac/exceptions.h @@ -56,7 +56,7 @@ namespace LACExceptions public: ExcPETScError (const int error_code); - virtual void print_info (std::ostream &out) const; + virtual void print_info (std::ostream &out) const override; const int error_code; }; diff --git a/include/deal.II/lac/matrix_out.h b/include/deal.II/lac/matrix_out.h index da8f9a2bc0..aaa4177e60 100644 --- a/include/deal.II/lac/matrix_out.h +++ b/include/deal.II/lac/matrix_out.h @@ -114,7 +114,7 @@ public: /** * Destructor. Declared in order to make it virtual. */ - virtual ~MatrixOut () = default; + virtual ~MatrixOut () override = default; /** * Generate a list of patches from the given matrix and use the given string @@ -163,13 +163,13 @@ private: * they shall write to a file. */ virtual const std::vector & - get_patches () const; + get_patches () const override; /** * Virtual function through which the names of data sets are obtained by the * output functions of the base class. */ - virtual std::vector get_dataset_names () const; + virtual std::vector get_dataset_names () const override; /** * Get the value of the matrix at gridpoint (i,j). Depending on the diff --git a/include/deal.II/lac/petsc_full_matrix.h b/include/deal.II/lac/petsc_full_matrix.h index 15ff21ff27..f297393726 100644 --- a/include/deal.II/lac/petsc_full_matrix.h +++ b/include/deal.II/lac/petsc_full_matrix.h @@ -83,7 +83,7 @@ namespace PETScWrappers * matrix. Since this is a sequential matrix, it returns the MPI_COMM_SELF * communicator. */ - virtual const MPI_Comm &get_mpi_communicator () const; + virtual const MPI_Comm &get_mpi_communicator () const override; private: diff --git a/include/deal.II/lac/petsc_matrix_base.h b/include/deal.II/lac/petsc_matrix_base.h index 6ab9d445f6..9e251571c9 100644 --- a/include/deal.II/lac/petsc_matrix_base.h +++ b/include/deal.II/lac/petsc_matrix_base.h @@ -306,7 +306,7 @@ namespace PETScWrappers /** * Destructor. Made virtual so that one can use pointers to this class. */ - virtual ~MatrixBase (); + virtual ~MatrixBase () override; /** * This operator assigns a scalar to a matrix. Since this does usually not diff --git a/include/deal.II/lac/petsc_matrix_free.h b/include/deal.II/lac/petsc_matrix_free.h index 43425fd387..68f39446df 100644 --- a/include/deal.II/lac/petsc_matrix_free.h +++ b/include/deal.II/lac/petsc_matrix_free.h @@ -177,7 +177,7 @@ namespace PETScWrappers * Return a reference to the MPI communicator object in use with this * matrix. */ - const MPI_Comm &get_mpi_communicator () const; + const MPI_Comm &get_mpi_communicator () const override; /** * Matrix-vector multiplication: let dst = M*src with M diff --git a/include/deal.II/lac/petsc_parallel_block_sparse_matrix.h b/include/deal.II/lac/petsc_parallel_block_sparse_matrix.h index aabaf7cf6d..8c94a0620e 100644 --- a/include/deal.II/lac/petsc_parallel_block_sparse_matrix.h +++ b/include/deal.II/lac/petsc_parallel_block_sparse_matrix.h @@ -106,7 +106,7 @@ namespace PETScWrappers /** * Destructor. */ - ~BlockSparseMatrix () = default; + ~BlockSparseMatrix () override = default; /** * Pseudo copy operator only copying empty objects. The sizes of the diff --git a/include/deal.II/lac/petsc_parallel_block_vector.h b/include/deal.II/lac/petsc_parallel_block_vector.h index c73cb5d6c7..3842ce3b85 100644 --- a/include/deal.II/lac/petsc_parallel_block_vector.h +++ b/include/deal.II/lac/petsc_parallel_block_vector.h @@ -136,7 +136,7 @@ namespace PETScWrappers /** * Destructor. Clears memory */ - ~BlockVector () = default; + ~BlockVector () override = default; /** * Copy operator: fill all components of the vector that are locally diff --git a/include/deal.II/lac/petsc_parallel_sparse_matrix.h b/include/deal.II/lac/petsc_parallel_sparse_matrix.h index e61328eff0..cc1f220134 100644 --- a/include/deal.II/lac/petsc_parallel_sparse_matrix.h +++ b/include/deal.II/lac/petsc_parallel_sparse_matrix.h @@ -151,7 +151,7 @@ namespace PETScWrappers /** * Destructor to free the PETSc object. */ - ~SparseMatrix (); + ~SparseMatrix () override; /** * Create a sparse matrix of dimensions @p m times @p n, with an initial @@ -352,7 +352,7 @@ namespace PETScWrappers * Return a reference to the MPI communicator object in use with this * matrix. */ - virtual const MPI_Comm &get_mpi_communicator () const; + virtual const MPI_Comm &get_mpi_communicator () const override; /** * @addtogroup Exceptions diff --git a/include/deal.II/lac/petsc_parallel_vector.h b/include/deal.II/lac/petsc_parallel_vector.h index f49610937f..73f5149780 100644 --- a/include/deal.II/lac/petsc_parallel_vector.h +++ b/include/deal.II/lac/petsc_parallel_vector.h @@ -267,7 +267,7 @@ namespace PETScWrappers * Release all memory and return to a state just like after having * called the default constructor. */ - void clear (); + virtual void clear () override; /** * Copy the given vector. Resize the present vector if necessary. Also @@ -353,7 +353,7 @@ namespace PETScWrappers * Return a reference to the MPI communicator object in use with this * vector. */ - const MPI_Comm &get_mpi_communicator () const; + const MPI_Comm &get_mpi_communicator () const override; /** * Print to a stream. @p precision denotes the desired precision with diff --git a/include/deal.II/lac/petsc_solver.h b/include/deal.II/lac/petsc_solver.h index 98d2117c63..3f04f11ff4 100644 --- a/include/deal.II/lac/petsc_solver.h +++ b/include/deal.II/lac/petsc_solver.h @@ -310,7 +310,7 @@ namespace PETScWrappers * Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ - virtual void set_solver_type (KSP &ksp) const; + virtual void set_solver_type (KSP &ksp) const override; }; @@ -361,7 +361,7 @@ namespace PETScWrappers * Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ - virtual void set_solver_type (KSP &ksp) const; + virtual void set_solver_type (KSP &ksp) const override; }; @@ -411,7 +411,7 @@ namespace PETScWrappers * Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ - virtual void set_solver_type (KSP &ksp) const; + virtual void set_solver_type (KSP &ksp) const override; }; @@ -461,7 +461,7 @@ namespace PETScWrappers * Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ - virtual void set_solver_type (KSP &ksp) const; + virtual void set_solver_type (KSP &ksp) const override; }; @@ -528,7 +528,7 @@ namespace PETScWrappers * Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ - virtual void set_solver_type (KSP &ksp) const; + virtual void set_solver_type (KSP &ksp) const override; }; @@ -579,7 +579,7 @@ namespace PETScWrappers * Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ - virtual void set_solver_type (KSP &ksp) const; + virtual void set_solver_type (KSP &ksp) const override; }; /** @@ -628,7 +628,7 @@ namespace PETScWrappers * Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ - virtual void set_solver_type (KSP &ksp) const; + virtual void set_solver_type (KSP &ksp) const override; }; @@ -678,7 +678,7 @@ namespace PETScWrappers * Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ - virtual void set_solver_type (KSP &ksp) const; + virtual void set_solver_type (KSP &ksp) const override; }; @@ -734,7 +734,7 @@ namespace PETScWrappers * Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ - virtual void set_solver_type (KSP &ksp) const; + virtual void set_solver_type (KSP &ksp) const override; }; @@ -784,7 +784,7 @@ namespace PETScWrappers * Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ - virtual void set_solver_type (KSP &ksp) const; + virtual void set_solver_type (KSP &ksp) const override; }; @@ -835,7 +835,7 @@ namespace PETScWrappers * Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ - virtual void set_solver_type (KSP &ksp) const; + virtual void set_solver_type (KSP &ksp) const override; }; @@ -890,7 +890,7 @@ namespace PETScWrappers * Function that takes a Krylov Subspace Solver context object, and sets * the type of solver that is appropriate for this class. */ - virtual void set_solver_type (KSP &ksp) const; + virtual void set_solver_type (KSP &ksp) const override; }; /** @@ -952,7 +952,7 @@ namespace PETScWrappers */ const AdditionalData additional_data; - virtual void set_solver_type (KSP &ksp) const; + virtual void set_solver_type (KSP &ksp) const override; private: /** diff --git a/include/deal.II/lac/petsc_sparse_matrix.h b/include/deal.II/lac/petsc_sparse_matrix.h index 8ccde62113..cad1efb0ea 100644 --- a/include/deal.II/lac/petsc_sparse_matrix.h +++ b/include/deal.II/lac/petsc_sparse_matrix.h @@ -197,7 +197,7 @@ namespace PETScWrappers * matrix. Since this is a sequential matrix, it returns the MPI_COMM_SELF * communicator. */ - virtual const MPI_Comm &get_mpi_communicator () const; + virtual const MPI_Comm &get_mpi_communicator () const override; /** * Return the number of rows of this matrix. diff --git a/include/deal.II/lac/petsc_vector_base.h b/include/deal.II/lac/petsc_vector_base.h index e5026cfea5..c325fe1c5b 100644 --- a/include/deal.II/lac/petsc_vector_base.h +++ b/include/deal.II/lac/petsc_vector_base.h @@ -266,7 +266,7 @@ namespace PETScWrappers /** * Destructor */ - virtual ~VectorBase (); + virtual ~VectorBase () override; /** * Release all memory and return to a state just like after having called diff --git a/include/deal.II/lac/pointer_matrix.h b/include/deal.II/lac/pointer_matrix.h index 2e0d93c085..9423660991 100644 --- a/include/deal.II/lac/pointer_matrix.h +++ b/include/deal.II/lac/pointer_matrix.h @@ -68,7 +68,7 @@ public: * of any derived class is called whenever a pointer-to-base-class object is * destroyed. */ - virtual ~PointerMatrixBase () = default; + virtual ~PointerMatrixBase () override = default; /** * Reset the object to its original state. @@ -153,7 +153,7 @@ public: const char *name); // Use doc from base class - virtual void clear(); + virtual void clear() override; /** * Return whether the object is empty. @@ -171,25 +171,25 @@ public: * Matrix-vector product. */ virtual void vmult (VectorType &dst, - const VectorType &src) const; + const VectorType &src) const override; /** * Transposed matrix-vector product. */ virtual void Tvmult (VectorType &dst, - const VectorType &src) const; + const VectorType &src) const override; /** * Matrix-vector product, adding to dst. */ virtual void vmult_add (VectorType &dst, - const VectorType &src) const; + const VectorType &src) const override; /** * Transposed matrix-vector product, adding to dst. */ virtual void Tvmult_add (VectorType &dst, - const VectorType &src) const; + const VectorType &src) const override; private: /** @@ -260,7 +260,7 @@ public: const char *name); // Use doc from base class - virtual void clear(); + virtual void clear() override; /** * Return whether the object is empty. @@ -283,25 +283,25 @@ public: * Matrix-vector product. */ virtual void vmult (VectorType &dst, - const VectorType &src) const; + const VectorType &src) const override; /** * Transposed matrix-vector product. */ virtual void Tvmult (VectorType &dst, - const VectorType &src) const; + const VectorType &src) const override; /** * Matrix-vector product, adding to dst. */ virtual void vmult_add (VectorType &dst, - const VectorType &src) const; + const VectorType &src) const override; /** * Transposed matrix-vector product, adding to dst. */ virtual void Tvmult_add (VectorType &dst, - const VectorType &src) const; + const VectorType &src) const override; private: /** diff --git a/include/deal.II/lac/precondition.h b/include/deal.II/lac/precondition.h index ddbccade5e..0dc5afbc6f 100644 --- a/include/deal.II/lac/precondition.h +++ b/include/deal.II/lac/precondition.h @@ -1803,11 +1803,11 @@ namespace internal internal::VectorImplementation::minimum_parallel_grain_size); } - ~VectorUpdatesRange() = default; + ~VectorUpdatesRange() override = default; virtual void apply_to_subrange (const std::size_t begin, - const std::size_t end) const + const std::size_t end) const override { updater.apply_to_subrange(begin, end); } diff --git a/include/deal.II/lac/precondition_block.h b/include/deal.II/lac/precondition_block.h index 3b9ba5dc1f..6612d4af4a 100644 --- a/include/deal.II/lac/precondition_block.h +++ b/include/deal.II/lac/precondition_block.h @@ -155,7 +155,7 @@ public: /** * Destructor. */ - ~PreconditionBlock() = default; + ~PreconditionBlock() override = default; /** * Initialize matrix and block size. We store the matrix and the block size diff --git a/include/deal.II/lac/precondition_selector.h b/include/deal.II/lac/precondition_selector.h index cf030d18b1..2e6010d8a9 100644 --- a/include/deal.II/lac/precondition_selector.h +++ b/include/deal.II/lac/precondition_selector.h @@ -110,7 +110,7 @@ public: /** * Destructor. */ - virtual ~PreconditionSelector(); + virtual ~PreconditionSelector() override; /** * Takes the matrix that is needed for preconditionings that involves a diff --git a/include/deal.II/lac/read_write_vector.h b/include/deal.II/lac/read_write_vector.h index af55656fa6..f17cf5b124 100644 --- a/include/deal.II/lac/read_write_vector.h +++ b/include/deal.II/lac/read_write_vector.h @@ -168,7 +168,7 @@ namespace LinearAlgebra /** * Destructor. */ - ~ReadWriteVector () = default; + ~ReadWriteVector () override = default; /** * Set the global size of the vector to @p size. The stored elements have diff --git a/include/deal.II/lac/scalapack.h b/include/deal.II/lac/scalapack.h index c3303ab700..f84fb13ef9 100644 --- a/include/deal.II/lac/scalapack.h +++ b/include/deal.II/lac/scalapack.h @@ -134,7 +134,7 @@ public: /** * Destructor */ - ~ScaLAPACKMatrix() = default; + ~ScaLAPACKMatrix() override = default; /** * Initialize the rectangular matrix with @p n_rows and @p n_cols diff --git a/include/deal.II/lac/solver_bicgstab.h b/include/deal.II/lac/solver_bicgstab.h index 47587c144d..6ac358603d 100644 --- a/include/deal.II/lac/solver_bicgstab.h +++ b/include/deal.II/lac/solver_bicgstab.h @@ -173,7 +173,7 @@ public: /** * Virtual destructor. */ - virtual ~SolverBicgstab (); + virtual ~SolverBicgstab () override; /** * Solve primal problem only. diff --git a/include/deal.II/lac/solver_cg.h b/include/deal.II/lac/solver_cg.h index 9318490b26..8e121328f3 100644 --- a/include/deal.II/lac/solver_cg.h +++ b/include/deal.II/lac/solver_cg.h @@ -122,7 +122,7 @@ public: /** * Virtual destructor. */ - virtual ~SolverCG () = default; + virtual ~SolverCG () override = default; /** * Solve the linear system $Ax=b$ for x. diff --git a/include/deal.II/lac/solver_control.h b/include/deal.II/lac/solver_control.h index 32c6e65084..47f7202676 100644 --- a/include/deal.II/lac/solver_control.h +++ b/include/deal.II/lac/solver_control.h @@ -99,9 +99,9 @@ public: : last_step (last_step), last_residual(last_residual) {} - virtual ~NoConvergence () noexcept = default; + virtual ~NoConvergence () noexcept override = default; - virtual void print_info (std::ostream &out) const + virtual void print_info (std::ostream &out) const override { out << "Iterative method reported convergence failure in step " << last_step << ". The residual in the last step was " << last_residual @@ -155,7 +155,7 @@ public: * Virtual destructor is needed as there are virtual functions in this * class. */ - virtual ~SolverControl() = default; + virtual ~SolverControl() override = default; /** * Interface to parameter file. @@ -429,7 +429,7 @@ public: * Virtual destructor is needed as there are virtual functions in this * class. */ - virtual ~ReductionControl() = default; + virtual ~ReductionControl() override = default; /** * Interface to parameter file. @@ -447,7 +447,7 @@ public: * value upon the first iteration. */ virtual State check (const unsigned int step, - const double check_value); + const double check_value) override; /** * Reduction factor. @@ -513,7 +513,7 @@ public: * Virtual destructor is needed as there are virtual functions in this * class. */ - virtual ~IterationNumberControl() = default; + virtual ~IterationNumberControl() override = default; /** * Decide about success or failure of an iteration. This function bases @@ -521,7 +521,7 @@ public: * the check value reached exactly zero. */ virtual State check (const unsigned int step, - const double check_value); + const double check_value) override; }; @@ -569,14 +569,14 @@ public: * Virtual destructor is needed as there are virtual functions in this * class. */ - virtual ~ConsecutiveControl() = default; + virtual ~ConsecutiveControl() override = default; /** * Decide about success or failure of an iteration, see the class description * above. */ virtual State check (const unsigned int step, - const double check_value); + const double check_value) override; protected: /** diff --git a/include/deal.II/lac/solver_minres.h b/include/deal.II/lac/solver_minres.h index 8b69182c98..1ef3ec0f86 100644 --- a/include/deal.II/lac/solver_minres.h +++ b/include/deal.II/lac/solver_minres.h @@ -94,7 +94,7 @@ public: /** * Virtual destructor. */ - virtual ~SolverMinRes () = default; + virtual ~SolverMinRes () override = default; /** * Solve the linear system $Ax=b$ for x. diff --git a/include/deal.II/lac/solver_richardson.h b/include/deal.II/lac/solver_richardson.h index 23e7b7fb9c..ead247f1d2 100644 --- a/include/deal.II/lac/solver_richardson.h +++ b/include/deal.II/lac/solver_richardson.h @@ -102,7 +102,7 @@ public: /** * Virtual destructor. */ - virtual ~SolverRichardson () = default; + virtual ~SolverRichardson () override = default; /** * Solve the linear system $Ax=b$ for x. diff --git a/include/deal.II/lac/solver_selector.h b/include/deal.II/lac/solver_selector.h index 8d948109e9..fa95b3f519 100644 --- a/include/deal.II/lac/solver_selector.h +++ b/include/deal.II/lac/solver_selector.h @@ -111,7 +111,7 @@ public: /** * Destructor */ - ~SolverSelector(); + ~SolverSelector() override; /** * Solver procedure. Calls the @p solve function of the @p solver whose @p diff --git a/include/deal.II/lac/sparse_decomposition.h b/include/deal.II/lac/sparse_decomposition.h index 57ca833fcb..7838d917c2 100644 --- a/include/deal.II/lac/sparse_decomposition.h +++ b/include/deal.II/lac/sparse_decomposition.h @@ -128,13 +128,13 @@ public: * Destruction. Mark the destructor pure to ensure that this class isn't * used directly, but only its derived classes. */ - virtual ~SparseLUDecomposition () = 0; + virtual ~SparseLUDecomposition () override = 0; /** * Deletes all member variables. Leaves the class in the state that it had * directly after calling the constructor */ - virtual void clear(); + virtual void clear() override; /** * Parameters for SparseDecomposition. diff --git a/include/deal.II/lac/sparse_direct.h b/include/deal.II/lac/sparse_direct.h index b616995229..c0b4eda294 100644 --- a/include/deal.II/lac/sparse_direct.h +++ b/include/deal.II/lac/sparse_direct.h @@ -104,7 +104,7 @@ public: /** * Destructor. */ - ~SparseDirectUMFPACK (); + ~SparseDirectUMFPACK () override; /** * @name Setting up a sparse factorization diff --git a/include/deal.II/lac/sparse_ilu.h b/include/deal.II/lac/sparse_ilu.h index 89b4d1a38a..20a3000959 100644 --- a/include/deal.II/lac/sparse_ilu.h +++ b/include/deal.II/lac/sparse_ilu.h @@ -128,7 +128,7 @@ public: * Determine an estimate for the memory consumption (in bytes) of this * object. */ - std::size_t memory_consumption () const; + std::size_t memory_consumption () const override; /** * @addtogroup Exceptions diff --git a/include/deal.II/lac/sparse_matrix.h b/include/deal.II/lac/sparse_matrix.h index c24101248b..e28ba1a9b2 100644 --- a/include/deal.II/lac/sparse_matrix.h +++ b/include/deal.II/lac/sparse_matrix.h @@ -589,7 +589,7 @@ public: * Destructor. Free all memory, but do not release the memory of the * sparsity structure. */ - virtual ~SparseMatrix (); + virtual ~SparseMatrix () override; /** * Copy operator. Since copying entire sparse matrices is a very expensive diff --git a/include/deal.II/lac/sparse_matrix_ez.h b/include/deal.II/lac/sparse_matrix_ez.h index 6a88fec2cd..de81654128 100644 --- a/include/deal.II/lac/sparse_matrix_ez.h +++ b/include/deal.II/lac/sparse_matrix_ez.h @@ -323,7 +323,7 @@ public: /** * Destructor. Free all memory. */ - ~SparseMatrixEZ () = default; + ~SparseMatrixEZ () override = default; /** * Pseudo operator only copying empty objects. diff --git a/include/deal.II/lac/sparse_mic.h b/include/deal.II/lac/sparse_mic.h index dad565aed3..255019ce48 100644 --- a/include/deal.II/lac/sparse_mic.h +++ b/include/deal.II/lac/sparse_mic.h @@ -61,13 +61,13 @@ public: /** * Destructor. */ - virtual ~SparseMIC(); + virtual ~SparseMIC() override; /** * Deletes all member variables. Leaves the class in the state that it had * directly after calling the constructor */ - virtual void clear(); + virtual void clear() override; /** * Make the @p AdditionalData type in the base class accessible to this @@ -125,7 +125,7 @@ public: * Determine an estimate for the memory consumption (in bytes) of this * object. */ - std::size_t memory_consumption () const; + std::size_t memory_consumption () const override; /** * @addtogroup Exceptions diff --git a/include/deal.II/lac/sparsity_pattern.h b/include/deal.II/lac/sparsity_pattern.h index b545a488fb..4d8c4f1b96 100644 --- a/include/deal.II/lac/sparsity_pattern.h +++ b/include/deal.II/lac/sparsity_pattern.h @@ -486,7 +486,7 @@ public: /** * Destructor. */ - ~SparsityPattern () = default; + ~SparsityPattern () override = default; /** * Copy operator. For this the same holds as for the copy constructor: it is diff --git a/include/deal.II/lac/swappable_vector.h b/include/deal.II/lac/swappable_vector.h index 891253e585..1e8cb36fd2 100644 --- a/include/deal.II/lac/swappable_vector.h +++ b/include/deal.II/lac/swappable_vector.h @@ -76,7 +76,7 @@ public: * Destructor. If this class still owns a file to which temporary data was * stored, then it is deleted. */ - virtual ~SwappableVector (); + virtual ~SwappableVector () override; /** * Copy operator. Do mostly the same as the copy constructor does; if diff --git a/include/deal.II/lac/trilinos_block_sparse_matrix.h b/include/deal.II/lac/trilinos_block_sparse_matrix.h index 0d43fa17c7..7817dacec4 100644 --- a/include/deal.II/lac/trilinos_block_sparse_matrix.h +++ b/include/deal.II/lac/trilinos_block_sparse_matrix.h @@ -109,7 +109,7 @@ namespace TrilinosWrappers /** * Destructor. */ - ~BlockSparseMatrix (); + ~BlockSparseMatrix () override; /** * Pseudo copy operator only copying empty objects. The sizes of the block diff --git a/include/deal.II/lac/trilinos_epetra_communication_pattern.h b/include/deal.II/lac/trilinos_epetra_communication_pattern.h index 83da16386a..337b5e8798 100644 --- a/include/deal.II/lac/trilinos_epetra_communication_pattern.h +++ b/include/deal.II/lac/trilinos_epetra_communication_pattern.h @@ -55,14 +55,14 @@ namespace LinearAlgebra /** * Reinitialize the object. */ - void reinit(const IndexSet &vector_space_vector_index_set, - const IndexSet &read_write_vector_index_set, - const MPI_Comm &communicator); + virtual void reinit(const IndexSet &vector_space_vector_index_set, + const IndexSet &read_write_vector_index_set, + const MPI_Comm &communicator) override; /** * Return the underlying MPI communicator. */ - const MPI_Comm &get_mpi_communicator() const; + virtual const MPI_Comm &get_mpi_communicator() const override; /** * Return the underlying Epetra_Import object. diff --git a/include/deal.II/lac/trilinos_parallel_block_vector.h b/include/deal.II/lac/trilinos_parallel_block_vector.h index 3d57bc8509..45ad31ae2e 100644 --- a/include/deal.II/lac/trilinos_parallel_block_vector.h +++ b/include/deal.II/lac/trilinos_parallel_block_vector.h @@ -138,7 +138,7 @@ namespace TrilinosWrappers /** * Destructor. Clears memory */ - ~BlockVector () = default; + ~BlockVector () override = default; /** * Copy operator: fill all components of the vector that are locally diff --git a/include/deal.II/lac/trilinos_precondition.h b/include/deal.II/lac/trilinos_precondition.h index 32845199f0..1c3a1e4a4d 100644 --- a/include/deal.II/lac/trilinos_precondition.h +++ b/include/deal.II/lac/trilinos_precondition.h @@ -104,7 +104,7 @@ namespace TrilinosWrappers /** * Destructor. */ - ~PreconditionBase () = default; + ~PreconditionBase () override = default; /** * Destroys the preconditioner, leaving an object like just after having @@ -1505,7 +1505,7 @@ namespace TrilinosWrappers /** * Destructor. */ - ~PreconditionAMG(); + ~PreconditionAMG() override; /** @@ -1770,7 +1770,7 @@ namespace TrilinosWrappers /** * Destructor. */ - ~PreconditionAMGMueLu(); + ~PreconditionAMGMueLu() override; /** * Let Trilinos compute a multilevel hierarchy for the solution of a @@ -1876,34 +1876,34 @@ namespace TrilinosWrappers * Apply the preconditioner, i.e., dst = src. */ void vmult (MPI::Vector &dst, - const MPI::Vector &src) const; + const MPI::Vector &src) const override; /** * Apply the transport conditioner, i.e., dst = src. */ void Tvmult (MPI::Vector &dst, - const MPI::Vector &src) const; + const MPI::Vector &src) const override; /** * Apply the preconditioner on deal.II data structures instead of the ones * provided in the Trilinos wrapper class, i.e., dst = src. */ void vmult (dealii::Vector &dst, - const dealii::Vector &src) const; + const dealii::Vector &src) const override; /** * Apply the transpose preconditioner on deal.II data structures instead * of the ones provided in the Trilinos wrapper class, i.e. dst = src. */ void Tvmult (dealii::Vector &dst, - const dealii::Vector &src) const; + const dealii::Vector &src) const override; /** * Apply the preconditioner on deal.II parallel data structures instead of * the ones provided in the Trilinos wrapper class, i.e., dst = src. */ void vmult (LinearAlgebra::distributed::Vector &dst, - const dealii::LinearAlgebra::distributed::Vector &src) const; + const dealii::LinearAlgebra::distributed::Vector &src) const override; /** * Apply the transpose preconditioner on deal.II parallel data structures @@ -1911,7 +1911,7 @@ namespace TrilinosWrappers * src. */ void Tvmult (LinearAlgebra::distributed::Vector &dst, - const dealii::LinearAlgebra::distributed::Vector &src) const; + const dealii::LinearAlgebra::distributed::Vector &src) const override; }; diff --git a/include/deal.II/lac/trilinos_sparse_matrix.h b/include/deal.II/lac/trilinos_sparse_matrix.h index be66f900eb..bf6ec98f9f 100644 --- a/include/deal.II/lac/trilinos_sparse_matrix.h +++ b/include/deal.II/lac/trilinos_sparse_matrix.h @@ -583,7 +583,7 @@ namespace TrilinosWrappers /** * Destructor. Made virtual so that one can use pointers to this class. */ - virtual ~SparseMatrix () = default; + virtual ~SparseMatrix () override = default; /** * This function initializes the Trilinos matrix with a deal.II sparsity @@ -2206,7 +2206,7 @@ namespace TrilinosWrappers /** * Destructor */ - virtual ~TrilinosPayload() = default; + virtual ~TrilinosPayload() override = default; /** * Return a payload configured for identity operations @@ -2357,7 +2357,7 @@ namespace TrilinosWrappers * Epetra_Operator. */ virtual bool - UseTranspose () const; + UseTranspose () const override; /** * Sets an internal flag so that all operations performed by the matrix, @@ -2375,7 +2375,7 @@ namespace TrilinosWrappers * operations that may occur on different threads simultaneously. */ virtual int - SetUseTranspose (bool UseTranspose); + SetUseTranspose (bool UseTranspose) override; /** * Apply the vmult operation on a vector @p X (of internally defined @@ -2390,7 +2390,7 @@ namespace TrilinosWrappers */ virtual int Apply(const VectorType &X, - VectorType &Y) const; + VectorType &Y) const override; /** * Apply the vmult inverse operation on a vector @p X (of internally @@ -2411,7 +2411,7 @@ namespace TrilinosWrappers */ virtual int ApplyInverse(const VectorType &Y, - VectorType &X) const; + VectorType &X) const override; //@} /** @@ -2426,7 +2426,7 @@ namespace TrilinosWrappers * Epetra_Operator. */ virtual const char * - Label () const; + Label () const override; /** * Return a reference to the underlying MPI communicator for @@ -2436,7 +2436,7 @@ namespace TrilinosWrappers * Epetra_Operator. */ virtual const Epetra_Comm & - Comm () const; + Comm () const override; /** * Return the partitioning of the domain space of this matrix, i.e., the @@ -2446,7 +2446,7 @@ namespace TrilinosWrappers * Epetra_Operator. */ virtual const Epetra_Map & - OperatorDomainMap () const; + OperatorDomainMap () const override; /** * Return the partitioning of the range space of this matrix, i.e., the @@ -2457,7 +2457,7 @@ namespace TrilinosWrappers * Epetra_Operator. */ virtual const Epetra_Map & - OperatorRangeMap () const; + OperatorRangeMap () const override; //@} private: @@ -2499,7 +2499,7 @@ namespace TrilinosWrappers * Epetra_Operator. */ virtual bool - HasNormInf () const; + HasNormInf () const override; /** * Return the infinity norm of this operator. @@ -2509,7 +2509,7 @@ namespace TrilinosWrappers * Epetra_Operator. */ virtual double - NormInf () const; + NormInf () const override; }; /** diff --git a/include/deal.II/lac/trilinos_sparsity_pattern.h b/include/deal.II/lac/trilinos_sparsity_pattern.h index a2de29cf49..c8d2873499 100644 --- a/include/deal.II/lac/trilinos_sparsity_pattern.h +++ b/include/deal.II/lac/trilinos_sparsity_pattern.h @@ -329,7 +329,7 @@ namespace TrilinosWrappers /** * Destructor. Made virtual so that one can use pointers to this class. */ - virtual ~SparsityPattern () = default; + virtual ~SparsityPattern () override = default; /** * Initialize a sparsity pattern that is completely stored locally, having diff --git a/include/deal.II/lac/trilinos_vector.h b/include/deal.II/lac/trilinos_vector.h index 00bb298a7f..0fb9eaaca3 100644 --- a/include/deal.II/lac/trilinos_vector.h +++ b/include/deal.II/lac/trilinos_vector.h @@ -506,7 +506,7 @@ namespace TrilinosWrappers /** * Destructor. */ - ~Vector () = default; + ~Vector () override = default; /** * Release all memory and return to a state just like after having called diff --git a/include/deal.II/lac/vector.h b/include/deal.II/lac/vector.h index 7ead70f3e2..f05a1085be 100644 --- a/include/deal.II/lac/vector.h +++ b/include/deal.II/lac/vector.h @@ -225,7 +225,7 @@ public: * Destructor, deallocates memory. Made virtual to allow for derived classes * to behave properly. */ - virtual ~Vector () = default; + virtual ~Vector () override = default; /** * This function does nothing but exists for compatibility with the parallel diff --git a/include/deal.II/lac/vector_memory.h b/include/deal.II/lac/vector_memory.h index d3bb307309..70971f5747 100644 --- a/include/deal.II/lac/vector_memory.h +++ b/include/deal.II/lac/vector_memory.h @@ -110,7 +110,7 @@ public: * destroying objects of derived type through pointers to this base * class. */ - virtual ~VectorMemory () = default; + virtual ~VectorMemory () override = default; /** * Return a pointer to a new vector. The number of elements or their @@ -256,7 +256,7 @@ public: * same kind of service that std::unique provides * for arbitrary memory allocated on the heap. */ - virtual VectorType *alloc (); + virtual VectorType *alloc () override; /** * Return a vector and indicate that it is not going to be used any further @@ -275,7 +275,7 @@ public: * same kind of service that std::unique provides * for arbitrary memory allocated on the heap. */ - virtual void free (const VectorType *const v); + virtual void free (const VectorType *const v) override; }; @@ -329,7 +329,7 @@ public: * However, as discussed in the class documentation, this does not imply * that their memory is returned to the operating system. */ - virtual ~GrowingVectorMemory(); + virtual ~GrowingVectorMemory() override; /** * Return a pointer to a new vector. The number of elements or their @@ -349,7 +349,7 @@ public: * same kind of service that std::unique provides * for arbitrary memory allocated on the heap. */ - virtual VectorType *alloc (); + virtual VectorType *alloc () override; /** * Return a vector and indicate that it is not going to be used any further @@ -368,7 +368,7 @@ public: * same kind of service that std::unique provides * for arbitrary memory allocated on the heap. */ - virtual void free (const VectorType *const); + virtual void free (const VectorType *const) override; /** * Release all vectors that are not currently in use. diff --git a/include/deal.II/lac/vector_view.h b/include/deal.II/lac/vector_view.h index 2c14cbc6df..a26d115f8b 100644 --- a/include/deal.II/lac/vector_view.h +++ b/include/deal.II/lac/vector_view.h @@ -162,7 +162,7 @@ public: * This destructor will only reset the internal sizes and the internal * pointers, but it will NOT clear the memory. */ - ~VectorView(); + ~VectorView() override; /** * The reinit function of this object has a behavior which is different from @@ -205,7 +205,7 @@ public: * call this reinit function if you really know what you are doing. */ virtual void reinit (const size_type N, - const bool omit_zeroing_entries=false); + const bool omit_zeroing_entries=false) override; /** * This reinit function is equivalent to constructing a new object with the @@ -224,7 +224,7 @@ public: * This function is here to prevent memory corruption. It should never be * called, and will throw an exception if you try to do so. */ - virtual void swap (Vector &v); + virtual void swap (Vector &v) override; }; diff --git a/include/deal.II/matrix_free/matrix_free.h b/include/deal.II/matrix_free/matrix_free.h index ef2d78fbc7..fd7f21babb 100644 --- a/include/deal.II/matrix_free/matrix_free.h +++ b/include/deal.II/matrix_free/matrix_free.h @@ -454,7 +454,7 @@ public: /** * Destructor. */ - ~MatrixFree() = default; + ~MatrixFree() override = default; /** * Extracts the information needed to perform loops over cells. The diff --git a/include/deal.II/matrix_free/operators.h b/include/deal.II/matrix_free/operators.h index d5aabda170..26816548d8 100644 --- a/include/deal.II/matrix_free/operators.h +++ b/include/deal.II/matrix_free/operators.h @@ -203,7 +203,7 @@ namespace MatrixFreeOperators /** * Virtual destructor. */ - virtual ~Base() = default; + virtual ~Base() override = default; /** * Release all memory and return to a state just like after having called @@ -660,7 +660,7 @@ namespace MatrixFreeOperators /** * For preconditioning, we store a lumped mass matrix at the diagonal entries. */ - virtual void compute_diagonal (); + virtual void compute_diagonal () override; private: /** @@ -669,7 +669,7 @@ namespace MatrixFreeOperators * using initialize_dof_vector(). */ virtual void apply_add (VectorType &dst, - const VectorType &src) const; + const VectorType &src) const override; /** * For this operator, there is just a cell contribution. diff --git a/include/deal.II/meshworker/local_integrator.h b/include/deal.II/meshworker/local_integrator.h index 2bb3dd2f1c..0c574b797c 100644 --- a/include/deal.II/meshworker/local_integrator.h +++ b/include/deal.II/meshworker/local_integrator.h @@ -66,7 +66,7 @@ namespace MeshWorker /** * The empty virtual destructor. */ - virtual ~LocalIntegrator() = default; + virtual ~LocalIntegrator() override = default; /** * Virtual function for integrating on cells. Throws exception diff --git a/include/deal.II/meshworker/vector_selector.h b/include/deal.II/meshworker/vector_selector.h index f7e752eee7..51fe925114 100644 --- a/include/deal.II/meshworker/vector_selector.h +++ b/include/deal.II/meshworker/vector_selector.h @@ -199,7 +199,7 @@ namespace MeshWorker /** * Virtual, but empty destructor. */ - virtual ~VectorDataBase() = default; + virtual ~VectorDataBase() override = default; /** * The only function added to VectorSelector is an abstract virtual @@ -319,7 +319,7 @@ namespace MeshWorker const unsigned int component, const unsigned int n_comp, const unsigned int start, - const unsigned int size) const; + const unsigned int size) const override; virtual void mg_fill( std::vector > > &values, @@ -331,7 +331,7 @@ namespace MeshWorker const unsigned int component, const unsigned int n_comp, const unsigned int start, - const unsigned int size) const; + const unsigned int size) const override; /** * The memory used by this object. diff --git a/include/deal.II/multigrid/mg_base.h b/include/deal.II/multigrid/mg_base.h index 182177d1c3..02b740dd0b 100644 --- a/include/deal.II/multigrid/mg_base.h +++ b/include/deal.II/multigrid/mg_base.h @@ -50,7 +50,7 @@ public: /* * Virtual destructor. */ - virtual ~MGMatrixBase() = default; + virtual ~MGMatrixBase() override = default; /** * Matrix-vector-multiplication on a certain level. @@ -106,7 +106,7 @@ public: /** * Virtual destructor. */ - virtual ~MGCoarseGridBase () = default; + virtual ~MGCoarseGridBase () override = default; /** * Solution operator. @@ -171,7 +171,7 @@ public: /** * Destructor. Does nothing here, but needs to be declared virtual anyway. */ - virtual ~MGTransferBase() = default; + virtual ~MGTransferBase() override = default; /** * Prolongate a vector from level to_level-1 to level @@ -237,7 +237,7 @@ public: /** * Virtual destructor. */ - virtual ~MGSmootherBase() = default; + virtual ~MGSmootherBase() override = default; /** * Release matrices. diff --git a/include/deal.II/multigrid/mg_coarse.h b/include/deal.II/multigrid/mg_coarse.h index 3945059c65..d1b3371598 100644 --- a/include/deal.II/multigrid/mg_coarse.h +++ b/include/deal.II/multigrid/mg_coarse.h @@ -63,7 +63,7 @@ public: */ void operator() (const unsigned int level, VectorType &dst, - const VectorType &src) const; + const VectorType &src) const override; private: /** @@ -202,7 +202,7 @@ public: */ virtual void operator() (const unsigned int level, VectorType &dst, - const VectorType &src) const; + const VectorType &src) const override; private: /** @@ -260,7 +260,7 @@ public: void operator() (const unsigned int level, VectorType &dst, - const VectorType &src) const; + const VectorType &src) const override; private: /** diff --git a/include/deal.II/multigrid/mg_matrix.h b/include/deal.II/multigrid/mg_matrix.h index 84e10ea0e8..1abb13ad9a 100644 --- a/include/deal.II/multigrid/mg_matrix.h +++ b/include/deal.II/multigrid/mg_matrix.h @@ -74,12 +74,12 @@ namespace mg */ const LinearOperator &operator[] (unsigned int level) const; - virtual void vmult (const unsigned int level, VectorType &dst, const VectorType &src) const; - virtual void vmult_add (const unsigned int level, VectorType &dst, const VectorType &src) const; - virtual void Tvmult (const unsigned int level, VectorType &dst, const VectorType &src) const; - virtual void Tvmult_add (const unsigned int level, VectorType &dst, const VectorType &src) const; - virtual unsigned int get_minlevel() const; - virtual unsigned int get_maxlevel() const; + virtual void vmult (const unsigned int level, VectorType &dst, const VectorType &src) const override; + virtual void vmult_add (const unsigned int level, VectorType &dst, const VectorType &src) const override; + virtual void Tvmult (const unsigned int level, VectorType &dst, const VectorType &src) const override; + virtual void Tvmult_add (const unsigned int level, VectorType &dst, const VectorType &src) const override; + virtual unsigned int get_minlevel() const override; + virtual unsigned int get_maxlevel() const override; /** * Memory used by this object. diff --git a/include/deal.II/multigrid/mg_smoother.h b/include/deal.II/multigrid/mg_smoother.h index ead0facce4..5d84279946 100644 --- a/include/deal.II/multigrid/mg_smoother.h +++ b/include/deal.II/multigrid/mg_smoother.h @@ -216,14 +216,14 @@ namespace mg /** * Empty all vectors. */ - void clear (); + void clear () override; /** * The actual smoothing method. */ virtual void smooth (const unsigned int level, VectorType &u, - const VectorType &rhs) const; + const VectorType &rhs) const override; /** * The apply variant of smoothing, setting the vector u to zero before @@ -242,7 +242,7 @@ namespace mg */ virtual void apply (const unsigned int level, VectorType &u, - const VectorType &rhs) const; + const VectorType &rhs) const override; /** * Memory used by this object. @@ -504,14 +504,14 @@ public: /** * Empty all vectors. */ - void clear (); + void clear () override; /** * The actual smoothing method. */ virtual void smooth (const unsigned int level, VectorType &u, - const VectorType &rhs) const; + const VectorType &rhs) const override; /** * The apply variant of smoothing, setting the vector u to zero before @@ -530,7 +530,7 @@ public: */ virtual void apply (const unsigned int level, VectorType &u, - const VectorType &rhs) const; + const VectorType &rhs) const override; /** * Object containing relaxation methods. diff --git a/include/deal.II/multigrid/mg_transfer.h b/include/deal.II/multigrid/mg_transfer.h index 5503dbe708..6113bc1bbc 100644 --- a/include/deal.II/multigrid/mg_transfer.h +++ b/include/deal.II/multigrid/mg_transfer.h @@ -554,7 +554,7 @@ public: /** * Destructor. */ - virtual ~MGTransferPrebuilt () = default; + virtual ~MGTransferPrebuilt () override = default; /** * Initialize the constraints to be used in build_matrices(). @@ -594,7 +594,7 @@ public: */ virtual void prolongate (const unsigned int to_level, VectorType &dst, - const VectorType &src) const; + const VectorType &src) const override; /** * Restrict a vector from level from_level to level @@ -613,7 +613,7 @@ public: */ virtual void restrict_and_add (const unsigned int from_level, VectorType &dst, - const VectorType &src) const; + const VectorType &src) const override; /** * Finite element does not provide prolongation matrices. diff --git a/include/deal.II/multigrid/mg_transfer_block.h b/include/deal.II/multigrid/mg_transfer_block.h index a3f05a4874..1eb7f7556f 100644 --- a/include/deal.II/multigrid/mg_transfer_block.h +++ b/include/deal.II/multigrid/mg_transfer_block.h @@ -200,7 +200,7 @@ public: /** * Destructor. */ - virtual ~MGTransferBlock (); + virtual ~MGTransferBlock () override; /** * Initialize additional #factors and #memory if the restriction of the @@ -222,11 +222,11 @@ public: virtual void prolongate (const unsigned int to_level, BlockVector &dst, - const BlockVector &src) const; + const BlockVector &src) const override; virtual void restrict_and_add (const unsigned int from_level, BlockVector &dst, - const BlockVector &src) const; + const BlockVector &src) const override; /** * Transfer from a vector on the global grid to a multilevel vector for the @@ -327,7 +327,7 @@ public: /** * Destructor. */ - virtual ~MGTransferBlockSelect () = default; + virtual ~MGTransferBlockSelect () override = default; /** * Actually build the prolongation matrices for grouped blocks. @@ -353,11 +353,11 @@ public: virtual void prolongate (const unsigned int to_level, Vector &dst, - const Vector &src) const; + const Vector &src) const override; virtual void restrict_and_add (const unsigned int from_level, Vector &dst, - const Vector &src) const; + const Vector &src) const override; /** * Transfer a single block from a vector on the global grid to a multilevel diff --git a/include/deal.II/multigrid/mg_transfer_component.h b/include/deal.II/multigrid/mg_transfer_component.h index fb4895b1ae..b4e54bf042 100644 --- a/include/deal.II/multigrid/mg_transfer_component.h +++ b/include/deal.II/multigrid/mg_transfer_component.h @@ -186,7 +186,7 @@ public: /** * Destructor. */ - virtual ~MGTransferSelect () = default; + virtual ~MGTransferSelect () override = default; //TODO: rewrite docs; make sure defaulted args are actually allowed /** @@ -235,11 +235,11 @@ public: virtual void prolongate (const unsigned int to_level, Vector &dst, - const Vector &src) const; + const Vector &src) const override; virtual void restrict_and_add (const unsigned int from_level, Vector &dst, - const Vector &src) const; + const Vector &src) const override; /** * Transfer from a vector on the global grid to a multilevel vector for the diff --git a/include/deal.II/multigrid/mg_transfer_matrix_free.h b/include/deal.II/multigrid/mg_transfer_matrix_free.h index 88fe784ec7..ef5b47d7ff 100644 --- a/include/deal.II/multigrid/mg_transfer_matrix_free.h +++ b/include/deal.II/multigrid/mg_transfer_matrix_free.h @@ -70,7 +70,7 @@ public: /** * Destructor. */ - virtual ~MGTransferMatrixFree () = default; + virtual ~MGTransferMatrixFree () override = default; /** * Initialize the constraints to be used in build(). @@ -103,7 +103,7 @@ public: */ virtual void prolongate (const unsigned int to_level, LinearAlgebra::distributed::Vector &dst, - const LinearAlgebra::distributed::Vector &src) const; + const LinearAlgebra::distributed::Vector &src) const override; /** * Restrict a vector from level from_level to level @@ -125,7 +125,7 @@ public: */ virtual void restrict_and_add (const unsigned int from_level, LinearAlgebra::distributed::Vector &dst, - const LinearAlgebra::distributed::Vector &src) const; + const LinearAlgebra::distributed::Vector &src) const override; /** * Restrict fine-mesh field @p src to each multigrid level in @p mg_dof and @@ -289,7 +289,7 @@ public: /** * Destructor. */ - virtual ~MGTransferBlockMatrixFree () = default; + virtual ~MGTransferBlockMatrixFree () override = default; /** * Initialize the constraints to be used in build(). @@ -332,7 +332,7 @@ public: */ virtual void prolongate (const unsigned int to_level, LinearAlgebra::distributed::BlockVector &dst, - const LinearAlgebra::distributed::BlockVector &src) const; + const LinearAlgebra::distributed::BlockVector &src) const override; /** * Restrict a vector from level from_level to level @@ -354,7 +354,7 @@ public: */ virtual void restrict_and_add (const unsigned int from_level, LinearAlgebra::distributed::BlockVector &dst, - const LinearAlgebra::distributed::BlockVector &src) const; + const LinearAlgebra::distributed::BlockVector &src) const override; /** * Transfer from a block-vector on the global grid to block-vectors defined diff --git a/include/deal.II/numerics/data_out_dof_data.h b/include/deal.II/numerics/data_out_dof_data.h index 8f7818d7a0..9b0bf99d28 100644 --- a/include/deal.II/numerics/data_out_dof_data.h +++ b/include/deal.II/numerics/data_out_dof_data.h @@ -590,7 +590,7 @@ public: /** * Destructor. */ - virtual ~DataOut_DoFData (); + virtual ~DataOut_DoFData () override; /** * Designate a dof handler to be used to extract geometry data and the @@ -884,14 +884,14 @@ protected: * they shall write to a file. */ virtual - const std::vector &get_patches () const; + const std::vector &get_patches () const override; /** * Virtual function through which the names of data sets are obtained by the * output functions of the base class. */ virtual - std::vector get_dataset_names () const; + std::vector get_dataset_names () const override; /** * Extracts the finite elements stored in the dof_data object, including a @@ -906,7 +906,7 @@ protected: */ virtual std::vector > - get_vector_data_ranges () const; + get_vector_data_ranges () const override; /** * Make all template siblings friends. Needed for the merge_patches() diff --git a/include/deal.II/numerics/data_out_dof_data.templates.h b/include/deal.II/numerics/data_out_dof_data.templates.h index 3f259adce5..9fb4fdbe5d 100644 --- a/include/deal.II/numerics/data_out_dof_data.templates.h +++ b/include/deal.II/numerics/data_out_dof_data.templates.h @@ -470,7 +470,7 @@ namespace internal virtual double get_cell_data_value (const unsigned int cell_number, - const ComponentExtractor extract_component) const; + const ComponentExtractor extract_component) const override; /** * Given a FEValuesBase object, extract the values on the present cell @@ -481,7 +481,7 @@ namespace internal get_function_values (const FEValuesBase &fe_patch_values, const ComponentExtractor extract_component, - std::vector &patch_values) const; + std::vector &patch_values) const override; /** * Given a FEValuesBase object, extract the values on the present cell @@ -493,7 +493,7 @@ namespace internal get_function_values (const FEValuesBase &fe_patch_values, const ComponentExtractor extract_component, - std::vector > &patch_values_system) const; + std::vector > &patch_values_system) const override; /** * Given a FEValuesBase object, extract the gradients on the present @@ -504,7 +504,7 @@ namespace internal get_function_gradients (const FEValuesBase &fe_patch_values, const ComponentExtractor extract_component, - std::vector > &patch_gradients) const; + std::vector > &patch_gradients) const override; /** * Given a FEValuesBase object, extract the gradients on the present @@ -516,7 +516,7 @@ namespace internal get_function_gradients (const FEValuesBase &fe_patch_values, const ComponentExtractor extract_component, - std::vector > > &patch_gradients_system) const; + std::vector > > &patch_gradients_system) const override; /** * Given a FEValuesBase object, extract the second derivatives on the @@ -527,7 +527,7 @@ namespace internal get_function_hessians (const FEValuesBase &fe_patch_values, const ComponentExtractor extract_component, - std::vector > &patch_hessians) const; + std::vector > &patch_hessians) const override; /** * Given a FEValuesBase object, extract the second derivatives on the @@ -539,24 +539,24 @@ namespace internal get_function_hessians (const FEValuesBase &fe_patch_values, const ComponentExtractor extract_component, - std::vector > > &patch_hessians_system) const; + std::vector > > &patch_hessians_system) const override; /** * Return whether the data represented by (a derived class of) this object * represents a complex-valued (as opposed to real-valued) information. */ - virtual bool is_complex_valued () const; + virtual bool is_complex_valued () const override; /** * Clear all references to the vectors. */ - virtual void clear (); + virtual void clear () override; /** * Determine an estimate for the memory consumption (in bytes) of this * object. */ - virtual std::size_t memory_consumption () const; + virtual std::size_t memory_consumption () const override; private: /** diff --git a/include/deal.II/numerics/data_out_stack.h b/include/deal.II/numerics/data_out_stack.h index af2fc3aa9a..5666e2d93a 100644 --- a/include/deal.II/numerics/data_out_stack.h +++ b/include/deal.II/numerics/data_out_stack.h @@ -128,7 +128,7 @@ public: /** * Destructor. Only declared to make it @p virtual. */ - virtual ~DataOutStack () = default; + virtual ~DataOutStack () override = default; /** * Start the next set of data for a specific parameter value. The argument @@ -339,14 +339,14 @@ private: * data in the form of Patch structures (declared in the base class * DataOutBase) to the actual output function. */ - virtual const std::vector< dealii::DataOutBase::Patch > & get_patches () const; + virtual const std::vector< dealii::DataOutBase::Patch > & get_patches () const override; /** * Virtual function through which the names of data sets are obtained by the * output functions of the base class. */ - virtual std::vector get_dataset_names () const; + virtual std::vector get_dataset_names () const override; }; diff --git a/include/deal.II/numerics/data_postprocessor.h b/include/deal.II/numerics/data_postprocessor.h index 104d6e63b1..6e3070232e 100644 --- a/include/deal.II/numerics/data_postprocessor.h +++ b/include/deal.II/numerics/data_postprocessor.h @@ -430,7 +430,7 @@ public: * virtual to ensure that data postprocessors can be destroyed through * pointers to the base class. */ - virtual ~DataPostprocessor () = default; + virtual ~DataPostprocessor () override = default; /** * This is the main function which actually performs the postprocessing. The @@ -555,7 +555,7 @@ public: * quantities. Given the purpose of this class, this is a vector with a * single entry equal to the name given to the constructor. */ - virtual std::vector get_names () const; + virtual std::vector get_names () const override; /** * This function returns information about how the individual components of @@ -566,14 +566,14 @@ public: */ virtual std::vector - get_data_component_interpretation () const; + get_data_component_interpretation () const override; /** * Return, which data has to be provided to compute the derived quantities. * The flags returned here are the ones passed to the constructor of this * class. */ - virtual UpdateFlags get_needed_update_flags () const; + virtual UpdateFlags get_needed_update_flags () const override; private: /** @@ -790,7 +790,7 @@ public: * quantities. Given the purpose of this class, this is a vector with dim * entries all equal to the name given to the constructor. */ - virtual std::vector get_names () const; + virtual std::vector get_names () const override; /** * This function returns information about how the individual components of @@ -801,14 +801,14 @@ public: */ virtual std::vector - get_data_component_interpretation () const; + get_data_component_interpretation () const override; /** * Return which data has to be provided to compute the derived quantities. * The flags returned here are the ones passed to the constructor of this * class. */ - virtual UpdateFlags get_needed_update_flags () const; + virtual UpdateFlags get_needed_update_flags () const override; private: /** @@ -1029,7 +1029,7 @@ public: * quantities. Given the purpose of this class, this is a vector with dim * entries all equal to the name given to the constructor. */ - virtual std::vector get_names () const; + virtual std::vector get_names () const override; /** * This function returns information about how the individual components of @@ -1040,14 +1040,14 @@ public: */ virtual std::vector - get_data_component_interpretation () const; + get_data_component_interpretation () const override; /** * Return which data has to be provided to compute the derived quantities. * The flags returned here are the ones passed to the constructor of this * class. */ - virtual UpdateFlags get_needed_update_flags () const; + virtual UpdateFlags get_needed_update_flags () const override; private: /** diff --git a/include/deal.II/numerics/dof_output_operator.h b/include/deal.II/numerics/dof_output_operator.h index 490c124f16..9e5a07e132 100644 --- a/include/deal.II/numerics/dof_output_operator.h +++ b/include/deal.II/numerics/dof_output_operator.h @@ -54,7 +54,7 @@ namespace Algorithms void initialize (const DoFHandler &dof_handler); virtual OutputOperator & - operator << (const AnyData &vectors); + operator << (const AnyData &vectors) override; private: SmartPointer, diff --git a/include/deal.II/numerics/dof_output_operator.templates.h b/include/deal.II/numerics/dof_output_operator.templates.h index 3f625d68c1..587a2b8a91 100644 --- a/include/deal.II/numerics/dof_output_operator.templates.h +++ b/include/deal.II/numerics/dof_output_operator.templates.h @@ -66,7 +66,7 @@ namespace Algorithms out.write (out_filename); out.clear (); return *this; - } + }; } DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/numerics/fe_field_function.h b/include/deal.II/numerics/fe_field_function.h index 5230e21f87..9103e2d4d5 100644 --- a/include/deal.II/numerics/fe_field_function.h +++ b/include/deal.II/numerics/fe_field_function.h @@ -195,7 +195,7 @@ namespace Functions * information. */ virtual void vector_value (const Point &p, - Vector &values) const; + Vector &values) const override; /** * Return the value of the function at the given point. Unless there is @@ -215,7 +215,7 @@ namespace Functions * information. */ virtual typename VectorType::value_type value (const Point< dim > &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Set @p values to the point values of the specified component of the @@ -234,7 +234,7 @@ namespace Functions */ virtual void value_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** @@ -253,7 +253,7 @@ namespace Functions * information. */ virtual void vector_value_list (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; /** * Return the gradient of all components of the function at the given @@ -272,7 +272,7 @@ namespace Functions */ virtual void vector_gradient (const Point< dim > &p, - std::vector< Tensor< 1, dim,typename VectorType::value_type > > &gradients) const; + std::vector< Tensor< 1, dim,typename VectorType::value_type > > &gradients) const override; /** * Return the gradient of the specified component of the function at the @@ -290,7 +290,7 @@ namespace Functions * information. */ virtual Tensor<1,dim,typename VectorType::value_type> gradient(const Point< dim > &p, - const unsigned int component = 0)const; + const unsigned int component = 0)const override; /** * Return the gradient of all components of the function at all the given @@ -308,7 +308,7 @@ namespace Functions virtual void vector_gradient_list (const std::vector< Point< dim > > &p, std::vector< - std::vector< Tensor< 1, dim,typename VectorType::value_type > > > &gradients) const; + std::vector< Tensor< 1, dim,typename VectorType::value_type > > > &gradients) const override; /** * Return the gradient of the specified component of the function at all @@ -326,7 +326,7 @@ namespace Functions virtual void gradient_list (const std::vector< Point< dim > > &p, std::vector< Tensor< 1, dim,typename VectorType::value_type > > &gradients, - const unsigned int component=0) const; + const unsigned int component=0) const override; /** @@ -342,7 +342,7 @@ namespace Functions */ virtual typename VectorType::value_type laplacian (const Point &p, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Compute the Laplacian of all components at point p and store @@ -358,7 +358,7 @@ namespace Functions */ virtual void vector_laplacian (const Point &p, - Vector &values) const; + Vector &values) const override; /** * Compute the Laplacian of one component at a set of points. @@ -374,7 +374,7 @@ namespace Functions virtual void laplacian_list (const std::vector > &points, std::vector &values, - const unsigned int component = 0) const; + const unsigned int component = 0) const override; /** * Compute the Laplacians of all components at a set of points. @@ -389,7 +389,7 @@ namespace Functions */ virtual void vector_laplacian_list (const std::vector > &points, - std::vector > &values) const; + std::vector > &values) const override; /** * Given a set of points located in the domain (or, in the case of diff --git a/include/deal.II/numerics/time_dependent.h b/include/deal.II/numerics/time_dependent.h index c52f61f72a..cef8a96c9f 100644 --- a/include/deal.II/numerics/time_dependent.h +++ b/include/deal.II/numerics/time_dependent.h @@ -672,7 +672,7 @@ public: /** * Destructor. At present, this does nothing. */ - virtual ~TimeStepBase () = default; + virtual ~TimeStepBase () override = default; /** * Reconstruct all the data that is needed for this time level to work. This @@ -1326,7 +1326,7 @@ public: * Destructor. At present, this does not more than releasing the lock on the * coarse grid triangulation given to the constructor. */ - virtual ~TimeStepBase_Tria (); + virtual ~TimeStepBase_Tria () override; /** * Reconstruct all the data that is needed for this time level to work. This @@ -1348,7 +1348,7 @@ public: * likely is the case), preferably at the beginning so that your function * can take effect of the triangulation already existing. */ - virtual void wake_up (const unsigned int wakeup_level); + virtual void wake_up (const unsigned int wakeup_level) override; /** * This is the opposite function to @p wake_up. It is used to delete data or @@ -1363,7 +1363,7 @@ public: * this function from your overloaded version, preferably at the end so that * your function can use the triangulation as long as you need it. */ - virtual void sleep (const unsigned int); + virtual void sleep (const unsigned int) override; /** * Do the refinement according to the flags passed to the constructor of @@ -1411,7 +1411,7 @@ public: * amount memory used by the derived class, and add the result of this * function to your result. */ - virtual std::size_t memory_consumption () const; + virtual std::size_t memory_consumption () const override; /** * Exception diff --git a/include/deal.II/particles/particle_handler.h b/include/deal.II/particles/particle_handler.h index 4a30326bcd..a405e2f4f1 100644 --- a/include/deal.II/particles/particle_handler.h +++ b/include/deal.II/particles/particle_handler.h @@ -82,7 +82,7 @@ namespace Particles /** * Destructor. */ - ~ParticleHandler(); + ~ParticleHandler() override; /** * Initialize the particle handler. This function does not clear the diff --git a/source/base/logstream.cc b/source/base/logstream.cc index 45a9c1d41e..140405f505 100644 --- a/source/base/logstream.cc +++ b/source/base/logstream.cc @@ -169,12 +169,12 @@ LogStream::operator<< (std::ostream& (*p) (std::ostream &)) return newline_written_; } private: - int_type overflow(int_type ch) + int_type overflow(int_type ch) override { newline_written_ = true; return ch; } - int sync() + int sync() override { flushed_ = true; return 0; diff --git a/source/fe/fe_values.cc b/source/fe/fe_values.cc index fb368f2d2f..2b2d0bfcf3 100644 --- a/source/fe/fe_values.cc +++ b/source/fe/fe_values.cc @@ -2364,7 +2364,7 @@ public: * we have to have a conversion operator. */ virtual - operator typename Triangulation::cell_iterator () const; + operator typename Triangulation::cell_iterator () const override; /** * Return the number of degrees of freedom the DoF handler object has to @@ -2372,7 +2372,7 @@ public: */ virtual types::global_dof_index - n_dofs_for_dof_handler () const; + n_dofs_for_dof_handler () const override; #include "fe_values.decl.2.inst" @@ -2383,7 +2383,7 @@ public: virtual void get_interpolated_dof_values (const IndexSet &in, - Vector &out) const; + Vector &out) const override; private: /** @@ -2429,7 +2429,7 @@ public: * from and to the same time. */ virtual - operator typename Triangulation::cell_iterator () const; + operator typename Triangulation::cell_iterator () const override; /** * Implement the respective function of the base class. Since this is not @@ -2437,7 +2437,7 @@ public: */ virtual types::global_dof_index - n_dofs_for_dof_handler () const; + n_dofs_for_dof_handler () const override; #include "fe_values.decl.2.inst" @@ -2448,7 +2448,7 @@ public: virtual void get_interpolated_dof_values (const IndexSet &in, - Vector &out) const; + Vector &out) const override; private: /** diff --git a/source/fe/fe_values.decl.2.inst.in b/source/fe/fe_values.decl.2.inst.in index 17ef7438f3..13c6a5c205 100644 --- a/source/fe/fe_values.decl.2.inst.in +++ b/source/fe/fe_values.decl.2.inst.in @@ -27,5 +27,5 @@ for (VEC : VECTOR_TYPES) virtual void get_interpolated_dof_values (const VEC &in, - Vector &out) const; + Vector &out) const override; } diff --git a/source/lac/trilinos_solver.cc b/source/lac/trilinos_solver.cc index 688f76b3d4..157863aeaf 100644 --- a/source/lac/trilinos_solver.cc +++ b/source/lac/trilinos_solver.cc @@ -294,10 +294,10 @@ namespace TrilinosWrappers const double &reduction, const Epetra_LinearProblem &linear_problem); - virtual ~TrilinosReductionControl() = default; + virtual ~TrilinosReductionControl() override = default; virtual bool - ResidualVectorRequired () const + ResidualVectorRequired () const override { return status_test_collection->ResidualVectorRequired(); } @@ -306,7 +306,7 @@ namespace TrilinosWrappers CheckStatus (int CurrentIter, Epetra_MultiVector *CurrentResVector, double CurrentResNormEst, - bool SolutionUpdated) + bool SolutionUpdated) override { // Note: CurrentResNormEst is set to -1.0 if no estimate of the // residual value is available @@ -324,14 +324,14 @@ namespace TrilinosWrappers } virtual AztecOO_StatusType - GetStatus () const + GetStatus () const override { return status_test_collection->GetStatus(); } virtual std::ostream & Print (std::ostream &stream, - int indent = 0) const + int indent = 0) const override { return status_test_collection->Print(stream,indent); } diff --git a/source/matrix_free/task_info.cc b/source/matrix_free/task_info.cc index 478e950254..1abe3874a6 100644 --- a/source/matrix_free/task_info.cc +++ b/source/matrix_free/task_info.cc @@ -110,7 +110,7 @@ namespace internal is_blocked (is_blocked) {} - tbb::task *execute () + tbb::task *execute () override { work(); @@ -143,7 +143,7 @@ namespace internal is_blocked (is_blocked_in) {} - tbb::task *execute () + tbb::task *execute () override { tbb::empty_task *root = new( tbb::task::allocate_root() )tbb::empty_task; const unsigned int evens = task_info.partition_evens[partition]; @@ -267,7 +267,7 @@ namespace internal is_blocked (is_blocked_in) {} - tbb::task *execute () + tbb::task *execute () override { const unsigned int n_chunks = (task_info.cell_partition_data[partition+1]- task_info.cell_partition_data[partition]+ @@ -302,7 +302,7 @@ namespace internal do_compress(do_compress) {} - tbb::task *execute () + tbb::task *execute () override { if (do_compress == false) worker.vector_update_ghosts_finish(); -- 2.39.5