From: Daniel Arndt Date: Tue, 12 Sep 2017 13:56:29 +0000 (+0200) Subject: Default constructors and destructors X-Git-Tag: v9.0.0-rc1~1068^2~3 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=74f156d789176f81493787795e25e376f30adf9a;p=dealii.git Default constructors and destructors --- diff --git a/include/deal.II/algorithms/operator.h b/include/deal.II/algorithms/operator.h index 81561950b9..b2279bb6f2 100644 --- a/include/deal.II/algorithms/operator.h +++ b/include/deal.II/algorithms/operator.h @@ -106,7 +106,7 @@ namespace Algorithms template class OutputOperator : public Subscriptor { - OutputOperator(const OutputOperator &); + OutputOperator(const OutputOperator &) = delete; public: OutputOperator (); /** diff --git a/include/deal.II/algorithms/operator.templates.h b/include/deal.II/algorithms/operator.templates.h index 390186c997..328d455e58 100644 --- a/include/deal.II/algorithms/operator.templates.h +++ b/include/deal.II/algorithms/operator.templates.h @@ -26,8 +26,7 @@ DEAL_II_NAMESPACE_OPEN namespace Algorithms { template - OutputOperator::~OutputOperator() - {} + OutputOperator::~OutputOperator() = default; template OutputOperator::OutputOperator() diff --git a/include/deal.II/base/function.templates.h b/include/deal.II/base/function.templates.h index 1faee2fcc8..e27051877e 100644 --- a/include/deal.II/base/function.templates.h +++ b/include/deal.II/base/function.templates.h @@ -46,8 +46,7 @@ Function::Function (const unsigned int n_components, template -Function::~Function () -{} +Function::~Function () = default; @@ -681,8 +680,7 @@ VectorFunctionFromTensorFunction::VectorFunctionFromTensorFunction template -VectorFunctionFromTensorFunction::~VectorFunctionFromTensorFunction () -{} +VectorFunctionFromTensorFunction::~VectorFunctionFromTensorFunction () = default; template diff --git a/include/deal.II/base/function_time.templates.h b/include/deal.II/base/function_time.templates.h index 938092675e..85955b0653 100644 --- a/include/deal.II/base/function_time.templates.h +++ b/include/deal.II/base/function_time.templates.h @@ -30,8 +30,7 @@ FunctionTime::FunctionTime(const Number initial_time) template -FunctionTime::~FunctionTime() -{} +FunctionTime::~FunctionTime() = default; diff --git a/include/deal.II/base/parallel.h b/include/deal.II/base/parallel.h index 83909347d0..74a2c3b18b 100644 --- a/include/deal.II/base/parallel.h +++ b/include/deal.II/base/parallel.h @@ -844,8 +844,8 @@ namespace parallel inline - ParallelForInteger::~ParallelForInteger () - {} + ParallelForInteger::~ParallelForInteger () = default; + inline diff --git a/include/deal.II/base/parameter_handler.h b/include/deal.II/base/parameter_handler.h index 15afb0fe2e..35fb351083 100644 --- a/include/deal.II/base/parameter_handler.h +++ b/include/deal.II/base/parameter_handler.h @@ -802,12 +802,12 @@ private: /** * Inhibit automatic CopyConstructor. */ - ParameterHandler (const ParameterHandler &); + ParameterHandler (const ParameterHandler &) = delete; /** * Inhibit automatic assignment operator. */ - ParameterHandler &operator= (const ParameterHandler &); + ParameterHandler &operator= (const ParameterHandler &) = delete; public: /** diff --git a/include/deal.II/base/point.h b/include/deal.II/base/point.h index 103582dbde..40b387abcd 100644 --- a/include/deal.II/base/point.h +++ b/include/deal.II/base/point.h @@ -253,8 +253,7 @@ public: // and we can't use 'Point::Point () = default' here. template inline -Point::Point () -{} +Point::Point () = default; diff --git a/include/deal.II/base/table.h b/include/deal.II/base/table.h index cc9a40723d..8022846389 100644 --- a/include/deal.II/base/table.h +++ b/include/deal.II/base/table.h @@ -1799,8 +1799,7 @@ namespace internal template inline -TableBase::~TableBase () -{} +TableBase::~TableBase () = default; diff --git a/include/deal.II/base/tensor_function.templates.h b/include/deal.II/base/tensor_function.templates.h index d4cefb6d22..6e98ee34df 100644 --- a/include/deal.II/base/tensor_function.templates.h +++ b/include/deal.II/base/tensor_function.templates.h @@ -34,8 +34,7 @@ TensorFunction::TensorFunction (const Number initial_time) template -TensorFunction::~TensorFunction () -{} +TensorFunction::~TensorFunction () = default; template @@ -96,8 +95,7 @@ ConstantTensorFunction::ConstantTensorFunction ( template -ConstantTensorFunction::~ConstantTensorFunction () -{} +ConstantTensorFunction::~ConstantTensorFunction () = default; template diff --git a/include/deal.II/base/thread_local_storage.h b/include/deal.II/base/thread_local_storage.h index 00b7f896fa..5553034da4 100644 --- a/include/deal.II/base/thread_local_storage.h +++ b/include/deal.II/base/thread_local_storage.h @@ -181,8 +181,7 @@ namespace Threads template inline - ThreadLocalStorage::ThreadLocalStorage() - {} + ThreadLocalStorage::ThreadLocalStorage() = default; template diff --git a/include/deal.II/base/thread_management.h b/include/deal.II/base/thread_management.h index d6fa9a5711..eb76b61e22 100644 --- a/include/deal.II/base/thread_management.h +++ b/include/deal.II/base/thread_management.h @@ -104,7 +104,7 @@ namespace Threads * Destructor. Unlock the mutex. Since this is a dummy mutex class, this * of course does nothing. */ - ~ScopedLock () {} + ~ScopedLock () = default; }; /** @@ -719,7 +719,9 @@ namespace Threads private: RT *value; public: - inline return_value () : value(nullptr) {} + inline return_value () + : value(nullptr) + {} inline RT &get () const { diff --git a/include/deal.II/base/time_stepping.h b/include/deal.II/base/time_stepping.h index 8bac8c3c7b..73657368ad 100644 --- a/include/deal.II/base/time_stepping.h +++ b/include/deal.II/base/time_stepping.h @@ -83,7 +83,7 @@ namespace TimeStepping /** * Virtual destructor. */ - virtual ~TimeStepping() {} + virtual ~TimeStepping() = default; /** * Purely virtual function. This function is used to advance from time @p @@ -128,7 +128,7 @@ namespace TimeStepping /** * Virtual destructor. */ - virtual ~RungeKutta() {} + virtual ~RungeKutta() = default; /** * Purely virtual method used to initialize the Runge-Kutta method. @@ -210,7 +210,7 @@ namespace TimeStepping * you will want to call initialize(runge_kutta_method) * before it can be used. */ - ExplicitRungeKutta() {} + ExplicitRungeKutta() = default; /** * Constructor. This function calls initialize(runge_kutta_method). @@ -305,7 +305,7 @@ namespace TimeStepping * set_newton_solver_parameters(unsigned int,double) need to be called * before the object can be used. */ - ImplicitRungeKutta() {} + ImplicitRungeKutta() = default; /** * Constructor. This function calls initialize(runge_kutta_method) and @@ -439,7 +439,7 @@ namespace TimeStepping * set_time_adaptation_parameters(double, double, double, double, double, * double) need to be called before the object can be used. */ - EmbeddedExplicitRungeKutta() {} + EmbeddedExplicitRungeKutta() = default; /** * Constructor. This function calls initialize(runge_kutta_method) and diff --git a/include/deal.II/fe/fe.h b/include/deal.II/fe/fe.h index fc3165d1c6..f59bba7aa9 100644 --- a/include/deal.II/fe/fe.h +++ b/include/deal.II/fe/fe.h @@ -671,7 +671,7 @@ public: /** * Copy construction is forbidden. */ - InternalDataBase (const InternalDataBase &); + InternalDataBase (const InternalDataBase &) = delete; public: /** diff --git a/include/deal.II/fe/fe_tools.templates.h b/include/deal.II/fe/fe_tools.templates.h index 7bed398ebc..e247033ddb 100644 --- a/include/deal.II/fe/fe_tools.templates.h +++ b/include/deal.II/fe/fe_tools.templates.h @@ -1319,8 +1319,7 @@ namespace namespace FETools { template - FEFactoryBase::~FEFactoryBase() - {} + FEFactoryBase::~FEFactoryBase() = default; diff --git a/include/deal.II/fe/mapping.h b/include/deal.II/fe/mapping.h index 4a7df4f527..3ea53c36e5 100644 --- a/include/deal.II/fe/mapping.h +++ b/include/deal.II/fe/mapping.h @@ -529,7 +529,7 @@ public: /** * Copy construction is forbidden. */ - InternalDataBase (const InternalDataBase &); + InternalDataBase (const InternalDataBase &) = delete; public: /** diff --git a/include/deal.II/grid/filtered_iterator.h b/include/deal.II/grid/filtered_iterator.h index a7ac28c0f2..3fe1b1064d 100644 --- a/include/deal.II/grid/filtered_iterator.h +++ b/include/deal.II/grid/filtered_iterator.h @@ -691,7 +691,7 @@ private: * Mark the destructor virtual to allow destruction through pointers to * the base class. */ - virtual ~PredicateBase () {} + virtual ~PredicateBase () = default; /** * Abstract function which in derived classes denotes the evaluation of diff --git a/include/deal.II/lac/block_vector.templates.h b/include/deal.II/lac/block_vector.templates.h index e5d1027852..3d7d25e6b3 100644 --- a/include/deal.II/lac/block_vector.templates.h +++ b/include/deal.II/lac/block_vector.templates.h @@ -140,9 +140,10 @@ void BlockVector::reinit (const BlockVector &v, } + template -BlockVector::~BlockVector () -{} +BlockVector::~BlockVector () = default; + #ifdef DEAL_II_WITH_TRILINOS diff --git a/include/deal.II/lac/communication_pattern_base.h b/include/deal.II/lac/communication_pattern_base.h index 60e8bf8579..876d6c066f 100644 --- a/include/deal.II/lac/communication_pattern_base.h +++ b/include/deal.II/lac/communication_pattern_base.h @@ -41,7 +41,7 @@ namespace LinearAlgebra /** * Destructor. */ - virtual ~CommunicationPatternBase() {}; + virtual ~CommunicationPatternBase() = default; /** * Reinitialize the communication pattern. The first argument @p diff --git a/include/deal.II/lac/householder.h b/include/deal.II/lac/householder.h index d1272117fc..960dc9ddc6 100644 --- a/include/deal.II/lac/householder.h +++ b/include/deal.II/lac/householder.h @@ -126,8 +126,7 @@ private: // QR-transformation cf. Stoer 1 4.8.2 (p. 191) template -Householder::Householder() -{} +Householder::Householder() = default; diff --git a/include/deal.II/lac/petsc_matrix_base.h b/include/deal.II/lac/petsc_matrix_base.h index ec11fefd94..1a515ac24d 100644 --- a/include/deal.II/lac/petsc_matrix_base.h +++ b/include/deal.II/lac/petsc_matrix_base.h @@ -941,11 +941,11 @@ namespace PETScWrappers /** * purposefully not implemented */ - MatrixBase(const MatrixBase &); + MatrixBase(const MatrixBase &) = delete; /** * purposefully not implemented */ - MatrixBase &operator=(const MatrixBase &); + MatrixBase &operator=(const MatrixBase &) = delete; /** * An internal array of integer values that is used to store the column diff --git a/include/deal.II/lac/petsc_parallel_block_vector.h b/include/deal.II/lac/petsc_parallel_block_vector.h index cff6ca4120..f3162c43d7 100644 --- a/include/deal.II/lac/petsc_parallel_block_vector.h +++ b/include/deal.II/lac/petsc_parallel_block_vector.h @@ -357,8 +357,7 @@ namespace PETScWrappers } inline - BlockVector::~BlockVector () - {} + BlockVector::~BlockVector () = default; inline diff --git a/include/deal.II/lac/petsc_sparse_matrix.h b/include/deal.II/lac/petsc_sparse_matrix.h index d222d80755..2a0947a0c3 100644 --- a/include/deal.II/lac/petsc_sparse_matrix.h +++ b/include/deal.II/lac/petsc_sparse_matrix.h @@ -214,11 +214,11 @@ namespace PETScWrappers /** * Purposefully not implemented */ - SparseMatrix(const SparseMatrix &); + SparseMatrix(const SparseMatrix &) = delete; /** * Purposefully not implemented */ - SparseMatrix &operator= (const SparseMatrix &); + SparseMatrix &operator= (const SparseMatrix &) = delete; /** * Do the actual work for the respective reinit() function and the diff --git a/include/deal.II/lac/petsc_vector_base.h b/include/deal.II/lac/petsc_vector_base.h index d3103585e5..a3a9f516b2 100644 --- a/include/deal.II/lac/petsc_vector_base.h +++ b/include/deal.II/lac/petsc_vector_base.h @@ -761,7 +761,7 @@ namespace PETScWrappers * deliberately left as private (and undefined) to prevent accidental * usage. */ - VectorBase &operator=(const VectorBase &); + VectorBase &operator=(const VectorBase &) = delete; }; diff --git a/include/deal.II/lac/pointer_matrix.h b/include/deal.II/lac/pointer_matrix.h index 6bc7b10502..50cf9e7f7c 100644 --- a/include/deal.II/lac/pointer_matrix.h +++ b/include/deal.II/lac/pointer_matrix.h @@ -583,8 +583,7 @@ new_pointer_matrix_base(const TridiagonalMatrix &matrix, const Vector inline -PointerMatrixBase::~PointerMatrixBase () -{} +PointerMatrixBase::~PointerMatrixBase () = default; diff --git a/include/deal.II/lac/precondition.h b/include/deal.II/lac/precondition.h index b7a9533301..f4b167f06e 100644 --- a/include/deal.II/lac/precondition.h +++ b/include/deal.II/lac/precondition.h @@ -87,7 +87,7 @@ public: /** * Constructor. */ - AdditionalData () {} + AdditionalData () = default; }; /** @@ -1805,7 +1805,7 @@ namespace internal internal::Vector::minimum_parallel_grain_size); } - ~VectorUpdatesRange() {} + ~VectorUpdatesRange() = default; virtual void apply_to_subrange (const std::size_t begin, diff --git a/include/deal.II/lac/precondition_block.templates.h b/include/deal.II/lac/precondition_block.templates.h index 161fb544ed..eb81a04d05 100644 --- a/include/deal.II/lac/precondition_block.templates.h +++ b/include/deal.II/lac/precondition_block.templates.h @@ -46,8 +46,7 @@ AdditionalData (const size_type block_size, template -PreconditionBlockBase::~PreconditionBlockBase () -{} +PreconditionBlockBase::~PreconditionBlockBase () = default; template @@ -60,8 +59,7 @@ PreconditionBlock::PreconditionBlock (bool store) template -PreconditionBlock::~PreconditionBlock () -{} +PreconditionBlock::~PreconditionBlock () = default; template diff --git a/include/deal.II/lac/solver_cg.h b/include/deal.II/lac/solver_cg.h index 9b35b16480..8fca65a304 100644 --- a/include/deal.II/lac/solver_cg.h +++ b/include/deal.II/lac/solver_cg.h @@ -249,8 +249,7 @@ SolverCG::SolverCG (SolverControl &cn, template -SolverCG::~SolverCG () -{} +SolverCG::~SolverCG () = default; diff --git a/include/deal.II/lac/solver_control.h b/include/deal.II/lac/solver_control.h index 4632fd1f8a..c8e4613522 100644 --- a/include/deal.II/lac/solver_control.h +++ b/include/deal.II/lac/solver_control.h @@ -99,7 +99,7 @@ public: : last_step (last_step), last_residual(last_residual) {} - virtual ~NoConvergence () noexcept {} + virtual ~NoConvergence () noexcept = default; virtual void print_info (std::ostream &out) const { diff --git a/include/deal.II/lac/solver_richardson.h b/include/deal.II/lac/solver_richardson.h index 71253f0ff1..91e02102c1 100644 --- a/include/deal.II/lac/solver_richardson.h +++ b/include/deal.II/lac/solver_richardson.h @@ -193,8 +193,7 @@ SolverRichardson::SolverRichardson(SolverControl &cn, template -SolverRichardson::~SolverRichardson() -{} +SolverRichardson::~SolverRichardson() = default; template diff --git a/include/deal.II/lac/sparse_ilu.templates.h b/include/deal.II/lac/sparse_ilu.templates.h index 57c6eb8c7f..909950e857 100644 --- a/include/deal.II/lac/sparse_ilu.templates.h +++ b/include/deal.II/lac/sparse_ilu.templates.h @@ -29,8 +29,7 @@ DEAL_II_NAMESPACE_OPEN template -SparseILU::SparseILU () -{} +SparseILU::SparseILU () = default; diff --git a/include/deal.II/lac/sparse_matrix_ez.templates.h b/include/deal.II/lac/sparse_matrix_ez.templates.h index 90b3696d53..7589d89171 100644 --- a/include/deal.II/lac/sparse_matrix_ez.templates.h +++ b/include/deal.II/lac/sparse_matrix_ez.templates.h @@ -64,8 +64,7 @@ SparseMatrixEZ::SparseMatrixEZ(const size_type n_rows, template -SparseMatrixEZ::~SparseMatrixEZ() -{} +SparseMatrixEZ::~SparseMatrixEZ() = default; template diff --git a/include/deal.II/lac/tensor_product_matrix.h b/include/deal.II/lac/tensor_product_matrix.h index b9a4e2092c..e3a69861d5 100644 --- a/include/deal.II/lac/tensor_product_matrix.h +++ b/include/deal.II/lac/tensor_product_matrix.h @@ -206,8 +206,7 @@ private: template inline TensorProductMatrixSymmetricSum -::TensorProductMatrixSymmetricSum() -{} +::TensorProductMatrixSymmetricSum() = default; diff --git a/include/deal.II/lac/trilinos_sparsity_pattern.h b/include/deal.II/lac/trilinos_sparsity_pattern.h index af48b4ff1b..f3a26c9800 100644 --- a/include/deal.II/lac/trilinos_sparsity_pattern.h +++ b/include/deal.II/lac/trilinos_sparsity_pattern.h @@ -1228,10 +1228,7 @@ namespace TrilinosWrappers inline - Iterator::Iterator(const Iterator &i) - : - accessor(i.accessor) - {} + Iterator::Iterator(const Iterator &i) = default; diff --git a/include/deal.II/lac/vector_space_vector.h b/include/deal.II/lac/vector_space_vector.h index 19c328f1da..737cb6c1b0 100644 --- a/include/deal.II/lac/vector_space_vector.h +++ b/include/deal.II/lac/vector_space_vector.h @@ -230,20 +230,9 @@ namespace LinearAlgebra * Destructor. Declared as virtual so that inheriting classes (which may * manage their own memory) are destroyed correctly. */ - virtual ~VectorSpaceVector(); + virtual ~VectorSpaceVector() = default; }; /*@}*/ - - - -#ifndef DOXYGEN - // TODO we can get rid of this when we require C++11 by using '=default' - // above - template - inline - VectorSpaceVector::~VectorSpaceVector() - {} -#endif // DOXYGEN } DEAL_II_NAMESPACE_CLOSE diff --git a/include/deal.II/matrix_free/dof_info.templates.h b/include/deal.II/matrix_free/dof_info.templates.h index d6467e1fd4..06ebdc5431 100644 --- a/include/deal.II/matrix_free/dof_info.templates.h +++ b/include/deal.II/matrix_free/dof_info.templates.h @@ -130,25 +130,8 @@ namespace internal } - DoFInfo::DoFInfo (const DoFInfo &dof_info_in) - : - row_starts (dof_info_in.row_starts), - dof_indices (dof_info_in.dof_indices), - constraint_indicator (dof_info_in.constraint_indicator), - vector_partitioner (dof_info_in.vector_partitioner), - constrained_dofs (dof_info_in.constrained_dofs), - row_starts_plain_indices (dof_info_in.row_starts_plain_indices), - plain_dof_indices (dof_info_in.plain_dof_indices), - dimension (dof_info_in.dimension), - n_components (dof_info_in.n_components), - dofs_per_cell (dof_info_in.dofs_per_cell), - dofs_per_face (dof_info_in.dofs_per_face), - store_plain_indices (dof_info_in.store_plain_indices), - cell_active_fe_index (dof_info_in.cell_active_fe_index), - max_fe_index (dof_info_in.max_fe_index), - fe_index_conversion (dof_info_in.fe_index_conversion), - ghost_dofs (dof_info_in.ghost_dofs) - {} + + DoFInfo::DoFInfo (const DoFInfo &dof_info_in) = default; diff --git a/include/deal.II/matrix_free/matrix_free.templates.h b/include/deal.II/matrix_free/matrix_free.templates.h index 1961e09e81..5e3c94b560 100644 --- a/include/deal.II/matrix_free/matrix_free.templates.h +++ b/include/deal.II/matrix_free/matrix_free.templates.h @@ -59,8 +59,7 @@ MatrixFree::MatrixFree(const MatrixFree &other) template -MatrixFree::~MatrixFree() -{} +MatrixFree::~MatrixFree() = default; diff --git a/include/deal.II/matrix_free/operators.h b/include/deal.II/matrix_free/operators.h index be1293e32a..b2acd5ece4 100644 --- a/include/deal.II/matrix_free/operators.h +++ b/include/deal.II/matrix_free/operators.h @@ -883,9 +883,7 @@ namespace MatrixFreeOperators //----------------- Base operator ----------------------------- template - Base::~Base () - { - } + Base::~Base () = default; diff --git a/include/deal.II/meshworker/vector_selector.templates.h b/include/deal.II/meshworker/vector_selector.templates.h index 72a5c88ce1..4e90925b7b 100644 --- a/include/deal.II/meshworker/vector_selector.templates.h +++ b/include/deal.II/meshworker/vector_selector.templates.h @@ -26,8 +26,8 @@ DEAL_II_NAMESPACE_OPEN namespace MeshWorker { template - VectorDataBase::~VectorDataBase() - {} + VectorDataBase::~VectorDataBase() = default; + template @@ -37,9 +37,10 @@ namespace MeshWorker {} + template - VectorDataBase::VectorDataBase() - {} + VectorDataBase::VectorDataBase() = default; + template 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 65f1d724d5..33c36c616e 100644 --- a/include/deal.II/numerics/data_out_dof_data.templates.h +++ b/include/deal.II/numerics/data_out_dof_data.templates.h @@ -371,8 +371,7 @@ namespace internal template - DataEntryBase::~DataEntryBase () - {} + DataEntryBase::~DataEntryBase () = default; diff --git a/include/deal.II/numerics/matrix_creator.templates.h b/include/deal.II/numerics/matrix_creator.templates.h index cb41d38eb1..9cad1f0a77 100644 --- a/include/deal.II/numerics/matrix_creator.templates.h +++ b/include/deal.II/numerics/matrix_creator.templates.h @@ -622,7 +622,7 @@ namespace MatrixCreator { struct Scratch { - Scratch() {} + Scratch() = default; }; template diff --git a/include/deal.II/numerics/time_dependent.h b/include/deal.II/numerics/time_dependent.h index eeea7e1441..99d6b928ae 100644 --- a/include/deal.II/numerics/time_dependent.h +++ b/include/deal.II/numerics/time_dependent.h @@ -895,7 +895,7 @@ private: * private prevents the compiler to provide it's own, incorrect one if * anyone chose to copy such an object. */ - TimeStepBase (const TimeStepBase &); + TimeStepBase (const TimeStepBase &) = delete; /** * Copy operator. I can see no reason why someone might want to use it, so I @@ -903,7 +903,7 @@ private: * prevents the compiler to provide it's own, incorrect one if anyone chose * to copy such an object. */ - TimeStepBase &operator = (const TimeStepBase &); + TimeStepBase &operator = (const TimeStepBase &) = delete; // make the manager object a friend friend class TimeDependent; diff --git a/source/algorithms/operator.cc b/source/algorithms/operator.cc index 2ebf93e656..67d159441e 100644 --- a/source/algorithms/operator.cc +++ b/source/algorithms/operator.cc @@ -37,14 +37,17 @@ DEAL_II_NAMESPACE_OPEN namespace Algorithms { - OperatorBase::~OperatorBase() - {} + OperatorBase::~OperatorBase() = default; + + void OperatorBase::notify(const Event &e) { notifications += e; } + + void OperatorBase::clear_events () { diff --git a/source/base/auto_derivative_function.cc b/source/base/auto_derivative_function.cc index aed9d33fe7..579bf18a1d 100644 --- a/source/base/auto_derivative_function.cc +++ b/source/base/auto_derivative_function.cc @@ -37,9 +37,9 @@ AutoDerivativeFunction (const double hh, } + template -AutoDerivativeFunction::~AutoDerivativeFunction () -{} +AutoDerivativeFunction::~AutoDerivativeFunction () = default; diff --git a/source/base/convergence_table.cc b/source/base/convergence_table.cc index b106525cfe..2aa193206c 100644 --- a/source/base/convergence_table.cc +++ b/source/base/convergence_table.cc @@ -18,8 +18,8 @@ DEAL_II_NAMESPACE_OPEN -ConvergenceTable::ConvergenceTable() -{} +ConvergenceTable::ConvergenceTable() = default; + void ConvergenceTable::evaluate_convergence_rates(const std::string &data_column_key, diff --git a/source/base/data_out_base.cc b/source/base/data_out_base.cc index 70a4f87dce..26326ceca9 100644 --- a/source/base/data_out_base.cc +++ b/source/base/data_out_base.cc @@ -6382,10 +6382,9 @@ DataOutInterface::DataOutInterface () {} -template -DataOutInterface::~DataOutInterface () -{} +template +DataOutInterface::~DataOutInterface () = default; diff --git a/source/base/flow_function.cc b/source/base/flow_function.cc index 6a91d6daec..893a79bfb8 100644 --- a/source/base/flow_function.cc +++ b/source/base/flow_function.cc @@ -38,8 +38,7 @@ namespace Functions template - FlowFunction::~FlowFunction() - {} + FlowFunction::~FlowFunction() = default; template @@ -192,9 +191,10 @@ namespace Functions } + template - PoisseuilleFlow::~PoisseuilleFlow() - {} + PoisseuilleFlow::~PoisseuilleFlow() = default; + template @@ -288,9 +288,10 @@ namespace Functions {} + template - StokesCosine::~StokesCosine() - {} + StokesCosine::~StokesCosine() = default; + template @@ -659,8 +660,9 @@ namespace Functions } - Kovasznay::~Kovasznay() - {} + + Kovasznay::~Kovasznay() = default; + void Kovasznay::vector_values ( diff --git a/source/base/function_parser.cc b/source/base/function_parser.cc index 5b951aef00..05cd0b9658 100644 --- a/source/base/function_parser.cc +++ b/source/base/function_parser.cc @@ -58,8 +58,8 @@ FunctionParser::FunctionParser(const unsigned int n_components, template -FunctionParser::~FunctionParser() -{} +FunctionParser::~FunctionParser() = default; + #ifdef DEAL_II_WITH_MUPARSER diff --git a/source/base/parameter_handler.cc b/source/base/parameter_handler.cc index 55c45e49ab..e2a2f2a7b0 100644 --- a/source/base/parameter_handler.cc +++ b/source/base/parameter_handler.cc @@ -49,8 +49,7 @@ ParameterHandler::ParameterHandler () -ParameterHandler::~ParameterHandler () -{} +ParameterHandler::~ParameterHandler () = default; @@ -2111,9 +2110,7 @@ ParameterHandler::operator == (const ParameterHandler &prm2) const - -MultipleParameterLoop::UserClass::~UserClass () -{} +MultipleParameterLoop::UserClass::~UserClass () = default; @@ -2124,8 +2121,7 @@ MultipleParameterLoop::MultipleParameterLoop() -MultipleParameterLoop::~MultipleParameterLoop () -{} +MultipleParameterLoop::~MultipleParameterLoop () = default; diff --git a/source/base/patterns.cc b/source/base/patterns.cc index 340d5723c2..3d927962b4 100644 --- a/source/base/patterns.cc +++ b/source/base/patterns.cc @@ -127,8 +127,8 @@ namespace Patterns - PatternBase::~PatternBase () - {} + PatternBase::~PatternBase () = default; + std::size_t @@ -1155,8 +1155,8 @@ namespace Patterns const char *Anything::description_init = "[Anything"; - Anything::Anything () - {} + + Anything::Anything () = default; @@ -1298,8 +1298,8 @@ namespace Patterns const char *DirectoryName::description_init = "[DirectoryName"; - DirectoryName::DirectoryName () - {} + + DirectoryName::DirectoryName () = default; diff --git a/source/base/table_handler.cc b/source/base/table_handler.cc index a9f00ace36..486d30a4c0 100644 --- a/source/base/table_handler.cc +++ b/source/base/table_handler.cc @@ -31,8 +31,7 @@ DEAL_II_NAMESPACE_OPEN // inline and template functions namespace internal { - TableEntry::TableEntry () - {} + TableEntry::TableEntry () = default; double TableEntry::get_numeric_value () const diff --git a/source/distributed/shared_tria.cc b/source/distributed/shared_tria.cc index 2e794fc077..01e85ddc9b 100644 --- a/source/distributed/shared_tria.cc +++ b/source/distributed/shared_tria.cc @@ -228,8 +228,7 @@ namespace parallel template - Triangulation::~Triangulation () - {} + Triangulation::~Triangulation () = default; diff --git a/source/distributed/solution_transfer.cc b/source/distributed/solution_transfer.cc index ca1e80bab5..4cf08c0b16 100644 --- a/source/distributed/solution_transfer.cc +++ b/source/distributed/solution_transfer.cc @@ -57,8 +57,7 @@ namespace parallel template - SolutionTransfer::~SolutionTransfer () - {} + SolutionTransfer::~SolutionTransfer () = default; diff --git a/source/fe/fe.cc b/source/fe/fe.cc index 5b09abb34e..ea80d956eb 100644 --- a/source/fe/fe.cc +++ b/source/fe/fe.cc @@ -42,8 +42,7 @@ FiniteElement::InternalDataBase::InternalDataBase (): template -FiniteElement::InternalDataBase::~InternalDataBase () -{} +FiniteElement::InternalDataBase::~InternalDataBase () = default; @@ -161,6 +160,10 @@ FiniteElement::operator^ (unsigned int multiplicity) const +FiniteElement::~FiniteElement () = default; + + + template double FiniteElement::shape_value (const unsigned int, diff --git a/source/fe/fe_p1nc.cc b/source/fe/fe_p1nc.cc index 0d2bea0538..102ede8580 100644 --- a/source/fe/fe_p1nc.cc +++ b/source/fe/fe_p1nc.cc @@ -73,7 +73,7 @@ std::unique_ptr> -FE_P1NC::~FE_P1NC () {} +FE_P1NC::~FE_P1NC () = default; diff --git a/source/fe/fe_values.cc b/source/fe/fe_values.cc index 4892d82e31..7d3abc04af 100644 --- a/source/fe/fe_values.cc +++ b/source/fe/fe_values.cc @@ -2173,8 +2173,7 @@ public: template -FEValuesBase::CellIteratorBase::~CellIteratorBase () -{} +FEValuesBase::CellIteratorBase::~CellIteratorBase () = default; /* ---------------- classes derived from FEValuesBase::CellIteratorBase --------- */ diff --git a/source/fe/mapping.cc b/source/fe/mapping.cc index 425e986487..e429951747 100644 --- a/source/fe/mapping.cc +++ b/source/fe/mapping.cc @@ -21,8 +21,7 @@ DEAL_II_NAMESPACE_OPEN template -Mapping::~Mapping () -{} +Mapping::~Mapping () = default; template @@ -87,8 +86,7 @@ Mapping::InternalDataBase::InternalDataBase (): template -Mapping::InternalDataBase::~InternalDataBase () -{} +Mapping::InternalDataBase::~InternalDataBase () = default; diff --git a/source/fe/mapping_manifold.cc b/source/fe/mapping_manifold.cc index f827927517..4a67770d78 100644 --- a/source/fe/mapping_manifold.cc +++ b/source/fe/mapping_manifold.cc @@ -43,8 +43,7 @@ DEAL_II_NAMESPACE_OPEN template -MappingManifold::InternalData::InternalData () -{} +MappingManifold::InternalData::InternalData () = default; template @@ -175,8 +174,7 @@ initialize_face (const UpdateFlags update_flags, template -MappingManifold::MappingManifold () -{} +MappingManifold::MappingManifold () = default; diff --git a/source/grid/manifold.cc b/source/grid/manifold.cc index 19940e1c06..6a23eea84a 100644 --- a/source/grid/manifold.cc +++ b/source/grid/manifold.cc @@ -31,8 +31,7 @@ using namespace Manifolds; /* -------------------------- Manifold --------------------- */ template -Manifold::~Manifold () -{} +Manifold::~Manifold () = default; @@ -693,8 +692,7 @@ FlatManifold::get_tangent_vector (const Point &x1, /* -------------------------- ChartManifold --------------------- */ template -ChartManifold::~ChartManifold () -{} +ChartManifold::~ChartManifold () = default; diff --git a/source/grid/persistent_tria.cc b/source/grid/persistent_tria.cc index 5f7ac5c976..0980347645 100644 --- a/source/grid/persistent_tria.cc +++ b/source/grid/persistent_tria.cc @@ -57,8 +57,7 @@ PersistentTriangulation (const PersistentTriangulation &old_tria) template -PersistentTriangulation::~PersistentTriangulation () -{} +PersistentTriangulation::~PersistentTriangulation () = default; diff --git a/source/grid/tria_boundary.cc b/source/grid/tria_boundary.cc index 41db3af440..ead4d83681 100644 --- a/source/grid/tria_boundary.cc +++ b/source/grid/tria_boundary.cc @@ -29,8 +29,7 @@ DEAL_II_NAMESPACE_OPEN template -Boundary::~Boundary () -{} +Boundary::~Boundary () = default; template @@ -187,8 +186,7 @@ get_line_support_points (const unsigned int n_intermediate_points) const template -StraightBoundary::StraightBoundary () -{} +StraightBoundary::StraightBoundary () = default; template diff --git a/source/hp/fe_collection.cc b/source/hp/fe_collection.cc index b41bb529c7..0892432c83 100644 --- a/source/hp/fe_collection.cc +++ b/source/hp/fe_collection.cc @@ -87,8 +87,7 @@ namespace hp } template - FECollection::FECollection () - {} + FECollection::FECollection () = default; diff --git a/source/hp/mapping_collection.cc b/source/hp/mapping_collection.cc index a0a6865f29..3b3e1705eb 100644 --- a/source/hp/mapping_collection.cc +++ b/source/hp/mapping_collection.cc @@ -24,8 +24,7 @@ namespace hp { template - MappingCollection::MappingCollection () - {} + MappingCollection::MappingCollection () = default; diff --git a/source/lac/block_sparsity_pattern.cc b/source/lac/block_sparsity_pattern.cc index d51e74e5a5..248e578261 100644 --- a/source/lac/block_sparsity_pattern.cc +++ b/source/lac/block_sparsity_pattern.cc @@ -327,8 +327,7 @@ BlockSparsityPatternBase::print_gnuplot(std::ostream &out) -BlockSparsityPattern::BlockSparsityPattern () -{} +BlockSparsityPattern::BlockSparsityPattern () = default; @@ -422,8 +421,7 @@ BlockSparsityPattern::copy_from (const BlockDynamicSparsityPattern &dsp) -BlockDynamicSparsityPattern::BlockDynamicSparsityPattern () -{} +BlockDynamicSparsityPattern::BlockDynamicSparsityPattern () = default; @@ -520,8 +518,7 @@ BlockDynamicSparsityPattern::reinit ( namespace TrilinosWrappers { - BlockSparsityPattern::BlockSparsityPattern () - {} + BlockSparsityPattern::BlockSparsityPattern () = default; diff --git a/source/lac/chunk_sparsity_pattern.cc b/source/lac/chunk_sparsity_pattern.cc index 3db63c4b1d..1b77f41b34 100644 --- a/source/lac/chunk_sparsity_pattern.cc +++ b/source/lac/chunk_sparsity_pattern.cc @@ -91,8 +91,7 @@ ChunkSparsityPattern::ChunkSparsityPattern ( -ChunkSparsityPattern::~ChunkSparsityPattern () -{} +ChunkSparsityPattern::~ChunkSparsityPattern () = default; diff --git a/source/lac/matrix_out.cc b/source/lac/matrix_out.cc index 99a0037b2b..12d39c1b87 100644 --- a/source/lac/matrix_out.cc +++ b/source/lac/matrix_out.cc @@ -29,8 +29,7 @@ MatrixOut::Options::Options (const bool show_absolute_values, -MatrixOut::~MatrixOut () -{} +MatrixOut::~MatrixOut () = default; diff --git a/source/lac/petsc_parallel_block_sparse_matrix.cc b/source/lac/petsc_parallel_block_sparse_matrix.cc index 77f22484a5..b07a42d4a4 100644 --- a/source/lac/petsc_parallel_block_sparse_matrix.cc +++ b/source/lac/petsc_parallel_block_sparse_matrix.cc @@ -24,12 +24,10 @@ namespace PETScWrappers namespace MPI { - BlockSparseMatrix::BlockSparseMatrix () - {} + BlockSparseMatrix::BlockSparseMatrix () = default; - BlockSparseMatrix::~BlockSparseMatrix () - {} + BlockSparseMatrix::~BlockSparseMatrix () = default; BlockSparseMatrix & diff --git a/source/lac/petsc_precondition.cc b/source/lac/petsc_precondition.cc index 90039decba..93e72acc42 100644 --- a/source/lac/petsc_precondition.cc +++ b/source/lac/petsc_precondition.cc @@ -123,8 +123,7 @@ namespace PETScWrappers } - PreconditionJacobi::PreconditionJacobi () - {} + PreconditionJacobi::PreconditionJacobi () = default; PreconditionJacobi::PreconditionJacobi (const MatrixBase &matrix, @@ -175,8 +174,7 @@ namespace PETScWrappers } - PreconditionBlockJacobi::PreconditionBlockJacobi () - {} + PreconditionBlockJacobi::PreconditionBlockJacobi () = default; PreconditionBlockJacobi:: @@ -223,8 +221,7 @@ namespace PETScWrappers {} - PreconditionSOR::PreconditionSOR () - {} + PreconditionSOR::PreconditionSOR () = default; PreconditionSOR::PreconditionSOR (const MatrixBase &matrix, @@ -269,8 +266,7 @@ namespace PETScWrappers {} - PreconditionSSOR::PreconditionSSOR () - {} + PreconditionSSOR::PreconditionSSOR () = default; PreconditionSSOR::PreconditionSSOR (const MatrixBase &matrix, @@ -319,8 +315,7 @@ namespace PETScWrappers {} - PreconditionEisenstat::PreconditionEisenstat () - {} + PreconditionEisenstat::PreconditionEisenstat () = default; PreconditionEisenstat::PreconditionEisenstat (const MatrixBase &matrix, @@ -366,8 +361,7 @@ namespace PETScWrappers {} - PreconditionICC::PreconditionICC () - {} + PreconditionICC::PreconditionICC () = default; PreconditionICC::PreconditionICC (const MatrixBase &matrix, @@ -412,8 +406,7 @@ namespace PETScWrappers {} - PreconditionILU::PreconditionILU () - {} + PreconditionILU::PreconditionILU () = default; PreconditionILU::PreconditionILU (const MatrixBase &matrix, @@ -467,8 +460,7 @@ namespace PETScWrappers {} - PreconditionBoomerAMG::PreconditionBoomerAMG () - {} + PreconditionBoomerAMG::PreconditionBoomerAMG () = default; PreconditionBoomerAMG::PreconditionBoomerAMG (const MPI_Comm comm, const AdditionalData &additional_data_) @@ -586,8 +578,7 @@ namespace PETScWrappers {} - PreconditionParaSails::PreconditionParaSails () - {} + PreconditionParaSails::PreconditionParaSails () = default; PreconditionParaSails::PreconditionParaSails (const MatrixBase &matrix, @@ -682,8 +673,7 @@ namespace PETScWrappers /* ----------------- PreconditionNone ------------------------- */ - PreconditionNone::PreconditionNone () - {} + PreconditionNone::PreconditionNone () = default; PreconditionNone::PreconditionNone (const MatrixBase &matrix, @@ -728,8 +718,7 @@ namespace PETScWrappers {} - PreconditionLU::PreconditionLU () - {} + PreconditionLU::PreconditionLU () = default; PreconditionLU::PreconditionLU (const MatrixBase &matrix, diff --git a/source/lac/petsc_solver.cc b/source/lac/petsc_solver.cc index f0659b48ab..15f0d87523 100644 --- a/source/lac/petsc_solver.cc +++ b/source/lac/petsc_solver.cc @@ -49,8 +49,7 @@ namespace PETScWrappers - SolverBase::~SolverBase () - {} + SolverBase::~SolverBase () = default; diff --git a/source/lac/solver_control.cc b/source/lac/solver_control.cc index b01c280ef6..4533df2a72 100644 --- a/source/lac/solver_control.cc +++ b/source/lac/solver_control.cc @@ -48,8 +48,7 @@ SolverControl::SolverControl (const unsigned int maxiter, -SolverControl::~SolverControl() -{} +SolverControl::~SolverControl() = default; @@ -259,8 +258,7 @@ ReductionControl::operator= (const SolverControl &c) } -ReductionControl::~ReductionControl() -{} +ReductionControl::~ReductionControl() = default; SolverControl::State @@ -324,8 +322,7 @@ IterationNumberControl::IterationNumberControl(const unsigned int n, SolverControl (n, tolerance, m_log_history, m_log_result) {} -IterationNumberControl::~IterationNumberControl() -{} +IterationNumberControl::~IterationNumberControl() = default; SolverControl::State @@ -388,8 +385,7 @@ ConsecutiveControl::operator= (const SolverControl &c) -ConsecutiveControl::~ConsecutiveControl() -{} +ConsecutiveControl::~ConsecutiveControl() = default; SolverControl::State diff --git a/source/lac/trilinos_block_sparse_matrix.cc b/source/lac/trilinos_block_sparse_matrix.cc index 0ddfe18136..26ba1d38ba 100644 --- a/source/lac/trilinos_block_sparse_matrix.cc +++ b/source/lac/trilinos_block_sparse_matrix.cc @@ -24,8 +24,7 @@ DEAL_II_NAMESPACE_OPEN namespace TrilinosWrappers { - BlockSparseMatrix::BlockSparseMatrix () - {} + BlockSparseMatrix::BlockSparseMatrix () = default; @@ -44,12 +43,7 @@ namespace TrilinosWrappers BlockSparseMatrix & - BlockSparseMatrix::operator = (const BlockSparseMatrix &m) - { - BaseClass::operator = (m); - - return *this; - } + BlockSparseMatrix::operator = (const BlockSparseMatrix &m) = default; diff --git a/source/lac/trilinos_block_vector.cc b/source/lac/trilinos_block_vector.cc index a9e0ff757e..5d6f636c7e 100644 --- a/source/lac/trilinos_block_vector.cc +++ b/source/lac/trilinos_block_vector.cc @@ -68,8 +68,7 @@ namespace TrilinosWrappers - BlockVector::~BlockVector () - {} + BlockVector::~BlockVector () = default; diff --git a/source/lac/trilinos_precondition.cc b/source/lac/trilinos_precondition.cc index 5172593a14..7756993065 100644 --- a/source/lac/trilinos_precondition.cc +++ b/source/lac/trilinos_precondition.cc @@ -55,8 +55,7 @@ namespace TrilinosWrappers - PreconditionBase::~PreconditionBase() - {} + PreconditionBase::~PreconditionBase() = default; diff --git a/source/lac/trilinos_solver.cc b/source/lac/trilinos_solver.cc index 82b2defe92..7cd95fca82 100644 --- a/source/lac/trilinos_solver.cc +++ b/source/lac/trilinos_solver.cc @@ -68,8 +68,7 @@ namespace TrilinosWrappers - SolverBase::~SolverBase () - {} + SolverBase::~SolverBase () = default; @@ -318,7 +317,7 @@ namespace TrilinosWrappers const double &reduction, const Epetra_LinearProblem &linear_problem); - virtual ~TrilinosReductionControl() {} + virtual ~TrilinosReductionControl() = default; virtual bool ResidualVectorRequired () const @@ -722,8 +721,7 @@ namespace TrilinosWrappers - SolverDirect::~SolverDirect () - {} + SolverDirect::~SolverDirect () = default; diff --git a/source/lac/trilinos_sparse_matrix.cc b/source/lac/trilinos_sparse_matrix.cc index 24ee2f794d..2aa484d076 100644 --- a/source/lac/trilinos_sparse_matrix.cc +++ b/source/lac/trilinos_sparse_matrix.cc @@ -356,8 +356,7 @@ namespace TrilinosWrappers - SparseMatrix::~SparseMatrix () - {} + SparseMatrix::~SparseMatrix () = default; @@ -2701,8 +2700,7 @@ namespace TrilinosWrappers // Destructor - TrilinosPayload::~TrilinosPayload () - { } + TrilinosPayload::~TrilinosPayload () = default; diff --git a/source/lac/trilinos_sparsity_pattern.cc b/source/lac/trilinos_sparsity_pattern.cc index 0776cd0b92..5e09df631a 100644 --- a/source/lac/trilinos_sparsity_pattern.cc +++ b/source/lac/trilinos_sparsity_pattern.cc @@ -221,8 +221,7 @@ namespace TrilinosWrappers - SparsityPattern::~SparsityPattern () - {} + SparsityPattern::~SparsityPattern () = default; diff --git a/source/meshworker/mesh_worker.cc b/source/meshworker/mesh_worker.cc index c9e30fd3ab..46251ade07 100644 --- a/source/meshworker/mesh_worker.cc +++ b/source/meshworker/mesh_worker.cc @@ -72,8 +72,7 @@ namespace MeshWorker template - LocalIntegrator::~LocalIntegrator () - {} + LocalIntegrator::~LocalIntegrator () = default; template void diff --git a/source/multigrid/mg_base.cc b/source/multigrid/mg_base.cc index efb63321dd..b4e6bab9d4 100644 --- a/source/multigrid/mg_base.cc +++ b/source/multigrid/mg_base.cc @@ -28,18 +28,15 @@ DEAL_II_NAMESPACE_OPEN template -MGTransferBase::~MGTransferBase() -{} +MGTransferBase::~MGTransferBase() = default; template -MGMatrixBase::~MGMatrixBase() -{} +MGMatrixBase::~MGMatrixBase() = default; template -MGSmootherBase::~MGSmootherBase() -{} +MGSmootherBase::~MGSmootherBase() = default; template @@ -54,8 +51,7 @@ MGSmootherBase::apply (const unsigned int level, template -MGCoarseGridBase::~MGCoarseGridBase() -{} +MGCoarseGridBase::~MGCoarseGridBase() = default; // Explicit instantiations diff --git a/source/multigrid/mg_transfer_matrix_free.cc b/source/multigrid/mg_transfer_matrix_free.cc index 4ebfdc4492..0e9c7583fc 100644 --- a/source/multigrid/mg_transfer_matrix_free.cc +++ b/source/multigrid/mg_transfer_matrix_free.cc @@ -59,8 +59,7 @@ MGTransferMatrixFree::MGTransferMatrixFree (const MGConstrainedDoFs template -MGTransferMatrixFree::~MGTransferMatrixFree () -{} +MGTransferMatrixFree::~MGTransferMatrixFree () = default; @@ -554,8 +553,7 @@ MGTransferMatrixFree::memory_consumption() const template -MGTransferBlockMatrixFree::MGTransferBlockMatrixFree () -{} +MGTransferBlockMatrixFree::MGTransferBlockMatrixFree () = default; @@ -569,8 +567,7 @@ MGTransferBlockMatrixFree::MGTransferBlockMatrixFree (const MGConstr template -MGTransferBlockMatrixFree::~MGTransferBlockMatrixFree () -{} +MGTransferBlockMatrixFree::~MGTransferBlockMatrixFree () = default; diff --git a/source/multigrid/mg_transfer_prebuilt.cc b/source/multigrid/mg_transfer_prebuilt.cc index 098eac5d3d..1e2a68b185 100644 --- a/source/multigrid/mg_transfer_prebuilt.cc +++ b/source/multigrid/mg_transfer_prebuilt.cc @@ -41,8 +41,7 @@ DEAL_II_NAMESPACE_OPEN template -MGTransferPrebuilt::MGTransferPrebuilt () -{} +MGTransferPrebuilt::MGTransferPrebuilt () = default; @@ -63,8 +62,7 @@ MGTransferPrebuilt::MGTransferPrebuilt (const ConstraintMatrix &/*c* template -MGTransferPrebuilt::~MGTransferPrebuilt () -{} +MGTransferPrebuilt::~MGTransferPrebuilt () = default; diff --git a/source/multigrid/multigrid.cc b/source/multigrid/multigrid.cc index b85f72e930..65c56843c0 100644 --- a/source/multigrid/multigrid.cc +++ b/source/multigrid/multigrid.cc @@ -215,8 +215,7 @@ MGTransferSelect::MGTransferSelect (const ConstraintMatrix &c) {} template -MGTransferSelect::~MGTransferSelect () -{} +MGTransferSelect::~MGTransferSelect () = default; template @@ -280,8 +279,7 @@ MGTransferBlockSelect::MGTransferBlockSelect (const ConstraintMatrix &/* template -MGTransferBlockSelect::~MGTransferBlockSelect () -{} +MGTransferBlockSelect::~MGTransferBlockSelect () = default; diff --git a/source/numerics/data_out_stack.cc b/source/numerics/data_out_stack.cc index 46aaa60905..eab0961801 100644 --- a/source/numerics/data_out_stack.cc +++ b/source/numerics/data_out_stack.cc @@ -42,8 +42,7 @@ DataOutStack::DataVector::memory_consumption () con template -DataOutStack::~DataOutStack () -{} +DataOutStack::~DataOutStack () = default; template diff --git a/source/numerics/data_postprocessor.cc b/source/numerics/data_postprocessor.cc index 67678d14df..1ded8ae434 100644 --- a/source/numerics/data_postprocessor.cc +++ b/source/numerics/data_postprocessor.cc @@ -22,8 +22,7 @@ DEAL_II_NAMESPACE_OPEN // -------------------------- DataPostprocessor --------------------------- template -DataPostprocessor::~DataPostprocessor() -{} +DataPostprocessor::~DataPostprocessor() = default; diff --git a/source/numerics/derivative_approximation.cc b/source/numerics/derivative_approximation.cc index 4016237ca5..8866786410 100644 --- a/source/numerics/derivative_approximation.cc +++ b/source/numerics/derivative_approximation.cc @@ -735,12 +735,12 @@ namespace DerivativeApproximation { struct Scratch { - Scratch() {} + Scratch() = default; }; struct CopyData { - CopyData() {} + CopyData() = default; }; } } diff --git a/source/numerics/time_dependent.cc b/source/numerics/time_dependent.cc index bee615228c..bb979f04c7 100644 --- a/source/numerics/time_dependent.cc +++ b/source/numerics/time_dependent.cc @@ -264,8 +264,7 @@ TimeStepBase::TimeStepBase (const double time) : -TimeStepBase::~TimeStepBase () -{} +TimeStepBase::~TimeStepBase () = default;