]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Default constructors and destructors
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Tue, 12 Sep 2017 13:56:29 +0000 (15:56 +0200)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Thu, 14 Sep 2017 22:03:45 +0000 (00:03 +0200)
84 files changed:
include/deal.II/algorithms/operator.h
include/deal.II/algorithms/operator.templates.h
include/deal.II/base/function.templates.h
include/deal.II/base/function_time.templates.h
include/deal.II/base/parallel.h
include/deal.II/base/parameter_handler.h
include/deal.II/base/point.h
include/deal.II/base/table.h
include/deal.II/base/tensor_function.templates.h
include/deal.II/base/thread_local_storage.h
include/deal.II/base/thread_management.h
include/deal.II/base/time_stepping.h
include/deal.II/fe/fe.h
include/deal.II/fe/fe_tools.templates.h
include/deal.II/fe/mapping.h
include/deal.II/grid/filtered_iterator.h
include/deal.II/lac/block_vector.templates.h
include/deal.II/lac/communication_pattern_base.h
include/deal.II/lac/householder.h
include/deal.II/lac/petsc_matrix_base.h
include/deal.II/lac/petsc_parallel_block_vector.h
include/deal.II/lac/petsc_sparse_matrix.h
include/deal.II/lac/petsc_vector_base.h
include/deal.II/lac/pointer_matrix.h
include/deal.II/lac/precondition.h
include/deal.II/lac/precondition_block.templates.h
include/deal.II/lac/solver_cg.h
include/deal.II/lac/solver_control.h
include/deal.II/lac/solver_richardson.h
include/deal.II/lac/sparse_ilu.templates.h
include/deal.II/lac/sparse_matrix_ez.templates.h
include/deal.II/lac/tensor_product_matrix.h
include/deal.II/lac/trilinos_sparsity_pattern.h
include/deal.II/lac/vector_space_vector.h
include/deal.II/matrix_free/dof_info.templates.h
include/deal.II/matrix_free/matrix_free.templates.h
include/deal.II/matrix_free/operators.h
include/deal.II/meshworker/vector_selector.templates.h
include/deal.II/numerics/data_out_dof_data.templates.h
include/deal.II/numerics/matrix_creator.templates.h
include/deal.II/numerics/time_dependent.h
source/algorithms/operator.cc
source/base/auto_derivative_function.cc
source/base/convergence_table.cc
source/base/data_out_base.cc
source/base/flow_function.cc
source/base/function_parser.cc
source/base/parameter_handler.cc
source/base/patterns.cc
source/base/table_handler.cc
source/distributed/shared_tria.cc
source/distributed/solution_transfer.cc
source/fe/fe.cc
source/fe/fe_p1nc.cc
source/fe/fe_values.cc
source/fe/mapping.cc
source/fe/mapping_manifold.cc
source/grid/manifold.cc
source/grid/persistent_tria.cc
source/grid/tria_boundary.cc
source/hp/fe_collection.cc
source/hp/mapping_collection.cc
source/lac/block_sparsity_pattern.cc
source/lac/chunk_sparsity_pattern.cc
source/lac/matrix_out.cc
source/lac/petsc_parallel_block_sparse_matrix.cc
source/lac/petsc_precondition.cc
source/lac/petsc_solver.cc
source/lac/solver_control.cc
source/lac/trilinos_block_sparse_matrix.cc
source/lac/trilinos_block_vector.cc
source/lac/trilinos_precondition.cc
source/lac/trilinos_solver.cc
source/lac/trilinos_sparse_matrix.cc
source/lac/trilinos_sparsity_pattern.cc
source/meshworker/mesh_worker.cc
source/multigrid/mg_base.cc
source/multigrid/mg_transfer_matrix_free.cc
source/multigrid/mg_transfer_prebuilt.cc
source/multigrid/multigrid.cc
source/numerics/data_out_stack.cc
source/numerics/data_postprocessor.cc
source/numerics/derivative_approximation.cc
source/numerics/time_dependent.cc

index 81561950b971376e23d514dfabc0a068f2911f3b..b2279bb6f2ebcf8b8a7361c24c60805f0dba9751 100644 (file)
@@ -106,7 +106,7 @@ namespace Algorithms
   template <typename VectorType>
   class OutputOperator : public Subscriptor
   {
-    OutputOperator(const OutputOperator<VectorType> &);
+    OutputOperator(const OutputOperator<VectorType> &) = delete;
   public:
     OutputOperator ();
     /**
index 390186c997ade4e588f5ece1a48919721d425f55..328d455e5830e710d497daa851557aae650fde72 100644 (file)
@@ -26,8 +26,7 @@ DEAL_II_NAMESPACE_OPEN
 namespace Algorithms
 {
   template <typename VectorType>
-  OutputOperator<VectorType>::~OutputOperator()
-  {}
+  OutputOperator<VectorType>::~OutputOperator() = default;
 
   template <typename VectorType>
   OutputOperator<VectorType>::OutputOperator()
index 1faee2fcc88ee4475b587c86f37093ff91c27839..e27051877e6a23271ea47f923a9f4a98d45a2688 100644 (file)
@@ -46,8 +46,7 @@ Function<dim, Number>::Function (const unsigned int n_components,
 
 
 template <int dim, typename Number>
-Function<dim, Number>::~Function ()
-{}
+Function<dim, Number>::~Function () = default;
 
 
 
@@ -681,8 +680,7 @@ VectorFunctionFromTensorFunction<dim, Number>::VectorFunctionFromTensorFunction
 
 
 template <int dim, typename Number>
-VectorFunctionFromTensorFunction<dim, Number>::~VectorFunctionFromTensorFunction ()
-{}
+VectorFunctionFromTensorFunction<dim, Number>::~VectorFunctionFromTensorFunction () = default;
 
 
 template <int dim, typename Number>
index 938092675e5155400c6f21f2b17ac9437b0837f0..85955b06533ea16011a6c194aabf664a7611b8a6 100644 (file)
@@ -30,8 +30,7 @@ FunctionTime<Number>::FunctionTime(const Number initial_time)
 
 
 template <typename Number>
-FunctionTime<Number>::~FunctionTime()
-{}
+FunctionTime<Number>::~FunctionTime() = default;
 
 
 
index 83909347d078b5f5d735e53f369c18bdfcfae110..74a2c3b18bc481850e5f7f4a0f82a5eeff1d8b82 100644 (file)
@@ -844,8 +844,8 @@ namespace parallel
 
 
   inline
-  ParallelForInteger::~ParallelForInteger ()
-  {}
+  ParallelForInteger::~ParallelForInteger () = default;
+
 
 
   inline
index 15afb0fe2e9137138c05375042ca647550bb12ca..35fb351083fab5b9c9fe89be0284bf76265b62bf 100644 (file)
@@ -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:
   /**
index 103582dbde5899815475e6557e3a4e791ff66b44..40b387abcd750d39ece0e96a1a440d35a050cbc8 100644 (file)
@@ -253,8 +253,7 @@ public:
 // and we can't use 'Point<dim,Number>::Point () = default' here.
 template <int dim, typename Number>
 inline
-Point<dim,Number>::Point ()
-{}
+Point<dim,Number>::Point () = default;
 
 
 
index cc9a40723d61ac9e313606caa11d7eb36b902d1d..80228463892134a3b169de61759beab85c3e5219 100644 (file)
@@ -1799,8 +1799,7 @@ namespace internal
 
 template <int N, typename T>
 inline
-TableBase<N,T>::~TableBase ()
-{}
+TableBase<N,T>::~TableBase () = default;
 
 
 
index d4cefb6d2235745d2c28bc717e2bae4672ed6e03..6e98ee34dfe7c3e8f8557e89e26115468fbaeec2 100644 (file)
@@ -34,8 +34,7 @@ TensorFunction<rank, dim, Number>::TensorFunction (const Number initial_time)
 
 
 template <int rank, int dim, typename Number>
-TensorFunction<rank, dim, Number>::~TensorFunction ()
-{}
+TensorFunction<rank, dim, Number>::~TensorFunction () = default;
 
 
 template <int rank, int dim, typename Number>
@@ -96,8 +95,7 @@ ConstantTensorFunction<rank, dim, Number>::ConstantTensorFunction (
 
 
 template <int rank, int dim, typename Number>
-ConstantTensorFunction<rank, dim, Number>::~ConstantTensorFunction ()
-{}
+ConstantTensorFunction<rank, dim, Number>::~ConstantTensorFunction () = default;
 
 
 template <int rank, int dim, typename Number>
index 00b7f896fa8c76ccae84247fb029c3ed50d46f25..5553034da4dc06b13c81538e2b066af228b27bbe 100644 (file)
@@ -181,8 +181,7 @@ namespace Threads
 
   template <typename T>
   inline
-  ThreadLocalStorage<T>::ThreadLocalStorage()
-  {}
+  ThreadLocalStorage<T>::ThreadLocalStorage() = default;
 
 
   template <typename T>
index d6fa9a57113072e1ab3da89ad4d0388850a460a1..eb76b61e227377ca823c7d14b079e88e87671cca 100644 (file)
@@ -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
       {
index 8bac8c3c7b874e6bfbf96705bcecb805f42e5f1f..73657368adcd7bd0540fe1b571049ee11923f7d8 100644 (file)
@@ -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 <code>initialize(runge_kutta_method)</code>
      * 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
index fc3165d1c67de13b2775fabb94fa6ed691188aff..f59bba7aa98021d316cf707e3c724c1481caea3b 100644 (file)
@@ -671,7 +671,7 @@ public:
     /**
      * Copy construction is forbidden.
      */
-    InternalDataBase (const InternalDataBase &);
+    InternalDataBase (const InternalDataBase &) = delete;
 
   public:
     /**
index 7bed398ebc11f51b36e58cd7887e9cdd4ce72140..e247033ddbbf565bdef76cfa48029c5775252f52 100644 (file)
@@ -1319,8 +1319,7 @@ namespace
 namespace FETools
 {
   template <int dim, int spacedim>
-  FEFactoryBase<dim,spacedim>::~FEFactoryBase()
-  {}
+  FEFactoryBase<dim,spacedim>::~FEFactoryBase() = default;
 
 
 
index 4a7df4f5278ba0d7aae0d424f2015d41234e2920..3ea53c36e547ade9a36a93e3b4e22aee458026de 100644 (file)
@@ -529,7 +529,7 @@ public:
     /**
      * Copy construction is forbidden.
      */
-    InternalDataBase (const InternalDataBase &);
+    InternalDataBase (const InternalDataBase &) = delete;
 
   public:
     /**
index a7ac28c0f206f9318c62c899488cbdf933519b41..3fe1b1064d0bb070019dd96fe08eb5825de84760 100644 (file)
@@ -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
index e5d10278523e3beca667c6487507055f73e078bb..3d7d25e6b327957dfa1860b3c77dc1b95294e013 100644 (file)
@@ -140,9 +140,10 @@ void BlockVector<Number>::reinit (const BlockVector<Number2> &v,
 }
 
 
+
 template <typename Number>
-BlockVector<Number>::~BlockVector ()
-{}
+BlockVector<Number>::~BlockVector () = default;
+
 
 
 #ifdef DEAL_II_WITH_TRILINOS
index 60e8bf85794db413198dc34bee5f30f9a1df2242..876d6c066fc17f696243a9e6551b5c4dfe121a47 100644 (file)
@@ -41,7 +41,7 @@ namespace LinearAlgebra
     /**
      * Destructor.
      */
-    virtual ~CommunicationPatternBase() {};
+    virtual ~CommunicationPatternBase() = default;
 
     /**
      * Reinitialize the communication pattern. The first argument @p
index d1272117fce3b71a73a3c1207f6a98bee2ba96a2..960dc9ddc6a0794246407803bdf167a39d2fd0ee 100644 (file)
@@ -126,8 +126,7 @@ private:
 // QR-transformation cf. Stoer 1 4.8.2 (p. 191)
 
 template <typename number>
-Householder<number>::Householder()
-{}
+Householder<number>::Householder() = default;
 
 
 
index ec11fefd9444d65ef7b0d5a2607700866b2930ae..1a515ac24db25db1e41cdeb04d93c57858c8da64 100644 (file)
@@ -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
index cff6ca4120ce0054a41c857d8b52132b7dc20fd5..f3162c43d78de904954ddda67dc7c8efec4c3807 100644 (file)
@@ -357,8 +357,7 @@ namespace PETScWrappers
     }
 
     inline
-    BlockVector::~BlockVector ()
-    {}
+    BlockVector::~BlockVector () = default;
 
 
     inline
index d222d80755e543f276df73e00e2e1ff830222d2a..2a0947a0c37674d0ede85347dcb69f2f36b6c3bc 100644 (file)
@@ -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
index d3103585e5084c0d2b94d16594bb075cb431043f..a3a9f516b2d8d617f678c3f90166bc1631505878 100644 (file)
@@ -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;
   };
 
 
index 6bc7b1050200c93695b261c745135e69d0927045..50cf9e7f7c943ad0b2fab06ba4db9c12aa21a438 100644 (file)
@@ -583,8 +583,7 @@ new_pointer_matrix_base(const TridiagonalMatrix<numberm> &matrix, const Vector<n
 
 template <typename VectorType>
 inline
-PointerMatrixBase<VectorType>::~PointerMatrixBase ()
-{}
+PointerMatrixBase<VectorType>::~PointerMatrixBase () = default;
 
 
 
index b7a9533301e3854e27b80d51b63ce25ed3f02e71..f4b167f06e5d562a3c5e54b45b003ab4829f9e49 100644 (file)
@@ -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,
index 161fb544edcb6e8c2ad3ad0399c2109d23b9bc7b..eb81a04d05a16f21e8c70795fdf75c73d65cfd25 100644 (file)
@@ -46,8 +46,7 @@ AdditionalData (const size_type block_size,
 
 
 template <typename number>
-PreconditionBlockBase<number>::~PreconditionBlockBase ()
-{}
+PreconditionBlockBase<number>::~PreconditionBlockBase () = default;
 
 
 template <typename MatrixType, typename inverse_type>
@@ -60,8 +59,7 @@ PreconditionBlock<MatrixType,inverse_type>::PreconditionBlock (bool store)
 
 
 template <typename MatrixType, typename inverse_type>
-PreconditionBlock<MatrixType,inverse_type>::~PreconditionBlock ()
-{}
+PreconditionBlock<MatrixType,inverse_type>::~PreconditionBlock () = default;
 
 
 template <typename MatrixType, typename inverse_type>
index 9b35b16480d711be9f0d6bc7bdbae95308f1bf72..8fca65a3049a38b356a40788fe2d78a39fefe9a8 100644 (file)
@@ -249,8 +249,7 @@ SolverCG<VectorType>::SolverCG (SolverControl        &cn,
 
 
 template <typename VectorType>
-SolverCG<VectorType>::~SolverCG ()
-{}
+SolverCG<VectorType>::~SolverCG () = default;
 
 
 
index 4632fd1f8a559ce616df1a3eda75de429ff95d86..c8e46135227eb96ceb9ddc0b396af1853cc424c4 100644 (file)
@@ -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
     {
index 71253f0ff18fb80be917bbb5cff7fd69fc149750..91e02102c1064905ce4d1ecfa7b3d7c6668793ad 100644 (file)
@@ -193,8 +193,7 @@ SolverRichardson<VectorType>::SolverRichardson(SolverControl        &cn,
 
 
 template <class VectorType>
-SolverRichardson<VectorType>::~SolverRichardson()
-{}
+SolverRichardson<VectorType>::~SolverRichardson() = default;
 
 
 template <class VectorType>
index 57c6eb8c7f1c0ed1d2546a7da88cc3c1241454b8..909950e8576f48013d502553809e4bed334d7273 100644 (file)
@@ -29,8 +29,7 @@
 DEAL_II_NAMESPACE_OPEN
 
 template <typename number>
-SparseILU<number>::SparseILU ()
-{}
+SparseILU<number>::SparseILU () = default;
 
 
 
index 90b3696d533a3e8d3ae516a012137169b08c8f3b..7589d8917139b3b747cea76efe7fddbbccbec120 100644 (file)
@@ -64,8 +64,7 @@ SparseMatrixEZ<number>::SparseMatrixEZ(const size_type    n_rows,
 
 
 template <typename number>
-SparseMatrixEZ<number>::~SparseMatrixEZ()
-{}
+SparseMatrixEZ<number>::~SparseMatrixEZ() = default;
 
 
 template <typename number>
index b9a4e2092c0d862f5b400498c1e648f4de880a92..e3a69861d529df047e614844c1b009e094a8b11b 100644 (file)
@@ -206,8 +206,7 @@ private:
 template <int dim, typename Number, int size>
 inline
 TensorProductMatrixSymmetricSum<dim,Number,size>
-::TensorProductMatrixSymmetricSum()
-{}
+::TensorProductMatrixSymmetricSum() = default;
 
 
 
index af48b4ff1b36307fd0c1b692d03912cba0fb652a..f3a26c98007116aa4543caf6447f04a06804335e 100644 (file)
@@ -1228,10 +1228,7 @@ namespace TrilinosWrappers
 
 
     inline
-    Iterator::Iterator(const Iterator &i)
-      :
-      accessor(i.accessor)
-    {}
+    Iterator::Iterator(const Iterator &i) = default;
 
 
 
index 19c328f1dad0c7688a08c63041c3508677a13363..737cb6c1b0eb99c06748a39954de11ea4dc10a6f 100644 (file)
@@ -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 <typename Number>
-  inline
-  VectorSpaceVector<Number>::~VectorSpaceVector()
-  {}
-#endif // DOXYGEN
 }
 
 DEAL_II_NAMESPACE_CLOSE
index d6467e1fd4a1c389a0d51145883266b8bf834174..06ebdc54314d91756587da875981930ccce7fb02 100644 (file)
@@ -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;
 
 
 
index 1961e09e816a07182030ac90c7f1af65fb3f3ffa..5e3c94b5605b57ffccce8945c79b0782b0df5992 100644 (file)
@@ -59,8 +59,7 @@ MatrixFree<dim, Number>::MatrixFree(const MatrixFree<dim,Number> &other)
 
 
 template <int dim, typename Number>
-MatrixFree<dim,Number>::~MatrixFree()
-{}
+MatrixFree<dim,Number>::~MatrixFree() = default;
 
 
 
index be1293e32adea2ca0d1c1e9fd0799b6a853e14e3..b2acd5ece4ee2ac2d891557d9638bbaf565db3aa 100644 (file)
@@ -883,9 +883,7 @@ namespace MatrixFreeOperators
 
   //----------------- Base operator -----------------------------
   template <int dim, typename VectorType>
-  Base<dim,VectorType>::~Base ()
-  {
-  }
+  Base<dim,VectorType>::~Base () = default;
 
 
 
index 72a5c88ce1997b4d76116073e86b4cece6434ea4..4e90925b7bc734116ddf373009dc40d370e48403 100644 (file)
@@ -26,8 +26,8 @@ DEAL_II_NAMESPACE_OPEN
 namespace MeshWorker
 {
   template <int dim, int spacedim, typename Number>
-  VectorDataBase<dim, spacedim, Number>::~VectorDataBase()
-  {}
+  VectorDataBase<dim, spacedim, Number>::~VectorDataBase() = default;
+
 
 
   template <int dim, int spacedim, typename Number>
@@ -37,9 +37,10 @@ namespace MeshWorker
   {}
 
 
+
   template <int dim, int spacedim, typename Number>
-  VectorDataBase<dim, spacedim, Number>::VectorDataBase()
-  {}
+  VectorDataBase<dim, spacedim, Number>::VectorDataBase() = default;
+
 
 
   template <int dim, int spacedim, typename Number>
index 65f1d724d58dd8a0ce54eb92e27bb03390c46920..33c36c616e5c047c0ea8d2c12b1f92e32ac5dd48 100644 (file)
@@ -371,8 +371,7 @@ namespace internal
 
 
     template <typename DoFHandlerType>
-    DataEntryBase<DoFHandlerType>::~DataEntryBase ()
-    {}
+    DataEntryBase<DoFHandlerType>::~DataEntryBase () = default;
 
 
 
index cb41d38eb1053e88f1ff41977bad9360dd04cbab..9cad1f0a7763aa64926b17fa188ab99227f34983 100644 (file)
@@ -622,7 +622,7 @@ namespace MatrixCreator
     {
       struct Scratch
       {
-        Scratch() {}
+        Scratch() = default;
       };
 
       template <typename DoFHandlerType, typename number>
index eeea7e1441caa8339c91a1d29dc72e70b90f428d..99d6b928ae99fdb7cc74ce7daebd23fdb1251961 100644 (file)
@@ -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;
index 2ebf93e65612be45fcf39aff8daf798709ed5c4a..67d159441ec3dd05c49fe1fb07958876cbca10f4 100644 (file)
@@ -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 ()
   {
index aed9d33fe77f8239045306a80f479a95abfc8f61..579bf18a1d99e97536e5802f721c95299de5d4bb 100644 (file)
@@ -37,9 +37,9 @@ AutoDerivativeFunction (const double hh,
 }
 
 
+
 template <int dim>
-AutoDerivativeFunction<dim>::~AutoDerivativeFunction ()
-{}
+AutoDerivativeFunction<dim>::~AutoDerivativeFunction () = default;
 
 
 
index b106525cfe778fe08d51d7ea6cf47ec533afbf0d..2aa193206c879e03669e1c7c041a73c46119fcc4 100644 (file)
@@ -18,8 +18,8 @@
 
 DEAL_II_NAMESPACE_OPEN
 
-ConvergenceTable::ConvergenceTable()
-{}
+ConvergenceTable::ConvergenceTable() = default;
+
 
 
 void ConvergenceTable::evaluate_convergence_rates(const std::string &data_column_key,
index 70a4f87dcedf69cfb6f28148a4c3c97283d59a8f..26326ceca925e7c5a9ac3f8047abc05b9c0486cb 100644 (file)
@@ -6382,10 +6382,9 @@ DataOutInterface<dim,spacedim>::DataOutInterface ()
 {}
 
 
-template <int dim, int spacedim>
-DataOutInterface<dim,spacedim>::~DataOutInterface ()
-{}
 
+template <int dim, int spacedim>
+DataOutInterface<dim,spacedim>::~DataOutInterface () = default;
 
 
 
index 6a91d6daec0e244061cd865fbfa995d472fc466c..893a79bfb8f00319920729bbc1012b628b0fb7c9 100644 (file)
@@ -38,8 +38,7 @@ namespace Functions
 
 
   template <int dim>
-  FlowFunction<dim>::~FlowFunction()
-  {}
+  FlowFunction<dim>::~FlowFunction() = default;
 
 
   template <int dim>
@@ -192,9 +191,10 @@ namespace Functions
   }
 
 
+
   template <int dim>
-  PoisseuilleFlow<dim>::~PoisseuilleFlow()
-  {}
+  PoisseuilleFlow<dim>::~PoisseuilleFlow() = default;
+
 
 
   template <int dim>
@@ -288,9 +288,10 @@ namespace Functions
   {}
 
 
+
   template <int dim>
-  StokesCosine<dim>::~StokesCosine()
-  {}
+  StokesCosine<dim>::~StokesCosine() = default;
+
 
 
   template <int dim>
@@ -659,8 +660,9 @@ namespace Functions
   }
 
 
-  Kovasznay::~Kovasznay()
-  {}
+
+  Kovasznay::~Kovasznay() = default;
+
 
 
   void Kovasznay::vector_values (
index 5b951aef0079fe70327a53bc86f35742a32d4735..05cd0b9658b58fac631761e70fd610a20b1654d2 100644 (file)
@@ -58,8 +58,8 @@ FunctionParser<dim>::FunctionParser(const unsigned int n_components,
 
 
 template <int dim>
-FunctionParser<dim>::~FunctionParser()
-{}
+FunctionParser<dim>::~FunctionParser() = default;
+
 
 #ifdef DEAL_II_WITH_MUPARSER
 
index 55c45e49abfd4aec0e9df8585349a0e1d0627da6..e2a2f2a7b0e69c6115917815163fbae878622b98 100644 (file)
@@ -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;
 
 
 
index 340d5723c2e87b9631952bcdde625947682e43e6..3d927962b43a29b736c781350d653b01e50aa08a 100644 (file)
@@ -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;
 
 
 
index a9f00ace36821edc6563e3a71876e6d4c7c3ecb5..486d30a4c078db5817fff6a2398caa51728ac822 100644 (file)
@@ -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
index 2e794fc07754471a75698f8696d06f88503838e3..01e85ddc9beba93e2afc583112d77b7a8177b9c8 100644 (file)
@@ -228,8 +228,7 @@ namespace parallel
 
 
     template <int dim, int spacedim>
-    Triangulation<dim,spacedim>::~Triangulation ()
-    {}
+    Triangulation<dim,spacedim>::~Triangulation () = default;
 
 
 
index ca1e80bab5980dd8bf4a88221525eb665b8aaa8d..4cf08c0b16abc94e74dca6a1aeaf3fa9cb942501 100644 (file)
@@ -57,8 +57,7 @@ namespace parallel
 
 
     template <int dim, typename VectorType, typename DoFHandlerType>
-    SolutionTransfer<dim, VectorType, DoFHandlerType>::~SolutionTransfer ()
-    {}
+    SolutionTransfer<dim, VectorType, DoFHandlerType>::~SolutionTransfer () = default;
 
 
 
index 5b09abb34e59ab4e0cbe8ef9598b1848fb449222..ea80d956eb08f9e3d7c8591c5da2d02ba5f2b45f 100644 (file)
@@ -42,8 +42,7 @@ FiniteElement<dim, spacedim>::InternalDataBase::InternalDataBase ():
 
 
 template <int dim, int spacedim>
-FiniteElement<dim,spacedim>::InternalDataBase::~InternalDataBase ()
-{}
+FiniteElement<dim,spacedim>::InternalDataBase::~InternalDataBase () = default;
 
 
 
@@ -161,6 +160,10 @@ FiniteElement<dim, spacedim>::operator^ (unsigned int multiplicity) const
 
 
 
+FiniteElement<dim,spacedim>::~FiniteElement () = default;
+
+
+
 template <int dim, int spacedim>
 double
 FiniteElement<dim,spacedim>::shape_value (const unsigned int,
index 0d2bea0538019d33cc8f9a75f9e5731b490b83e3..102ede8580625f01f7996948d1a1a4008289f5cc 100644 (file)
@@ -73,7 +73,7 @@ std::unique_ptr<FiniteElement<2,2>>
 
 
 
-FE_P1NC::~FE_P1NC () {}
+FE_P1NC::~FE_P1NC () = default;
 
 
 
index 4892d82e31973ea956969503582a6410d175bb40..7d3abc04af3f3f040e18cf16ee4594177e0c2cde 100644 (file)
@@ -2173,8 +2173,7 @@ public:
 
 
 template <int dim, int spacedim>
-FEValuesBase<dim,spacedim>::CellIteratorBase::~CellIteratorBase ()
-{}
+FEValuesBase<dim,spacedim>::CellIteratorBase::~CellIteratorBase () = default;
 
 /* ---------------- classes derived from FEValuesBase<dim,spacedim>::CellIteratorBase --------- */
 
index 425e9864874b970791d7488667c70573d2049a5c..e4299517479cb50240d7b56657d3b526fcea4625 100644 (file)
@@ -21,8 +21,7 @@ DEAL_II_NAMESPACE_OPEN
 
 
 template <int dim, int spacedim>
-Mapping<dim, spacedim>::~Mapping ()
-{}
+Mapping<dim, spacedim>::~Mapping () = default;
 
 
 template <int dim, int spacedim>
@@ -87,8 +86,7 @@ Mapping<dim, spacedim>::InternalDataBase::InternalDataBase ():
 
 
 template <int dim, int spacedim>
-Mapping<dim, spacedim>::InternalDataBase::~InternalDataBase ()
-{}
+Mapping<dim, spacedim>::InternalDataBase::~InternalDataBase () = default;
 
 
 
index f8279275172e89de018df05365cf47247fd1dd78..4a67770d78ca3af77fff58394884e3fdd414e5da 100644 (file)
@@ -43,8 +43,7 @@
 DEAL_II_NAMESPACE_OPEN
 
 template <int dim, int spacedim>
-MappingManifold<dim,spacedim>::InternalData::InternalData ()
-{}
+MappingManifold<dim,spacedim>::InternalData::InternalData () = default;
 
 
 template <int dim, int spacedim>
@@ -175,8 +174,7 @@ initialize_face (const UpdateFlags      update_flags,
 
 
 template <int dim, int spacedim>
-MappingManifold<dim,spacedim>::MappingManifold ()
-{}
+MappingManifold<dim,spacedim>::MappingManifold () = default;
 
 
 
index 19940e1c068e476d5b9aeb310876159ed3b9dd06..6a23eea84a59a2474ff3cbc092e9c0bb86a169c9 100644 (file)
@@ -31,8 +31,7 @@ using namespace Manifolds;
 
 /* -------------------------- Manifold --------------------- */
 template <int dim, int spacedim>
-Manifold<dim, spacedim>::~Manifold ()
-{}
+Manifold<dim, spacedim>::~Manifold () = default;
 
 
 
@@ -693,8 +692,7 @@ FlatManifold<dim, spacedim>::get_tangent_vector (const Point<spacedim> &x1,
 /* -------------------------- ChartManifold --------------------- */
 
 template <int dim, int spacedim, int chartdim>
-ChartManifold<dim,spacedim,chartdim>::~ChartManifold ()
-{}
+ChartManifold<dim,spacedim,chartdim>::~ChartManifold () = default;
 
 
 
index 5f7ac5c976eb257ded8dfcc88cb66ab10516b11d..09803476453a518fbada76e6c96750a87ec9690f 100644 (file)
@@ -57,8 +57,7 @@ PersistentTriangulation (const PersistentTriangulation<dim,spacedim> &old_tria)
 
 
 template <int dim, int spacedim>
-PersistentTriangulation<dim,spacedim>::~PersistentTriangulation ()
-{}
+PersistentTriangulation<dim,spacedim>::~PersistentTriangulation () = default;
 
 
 
index 41db3af440c2699c3dd9972e2777f1b43cabc2c5..ead4d8368174dcbdb887088a9b604c70a81f2c67 100644 (file)
@@ -29,8 +29,7 @@ DEAL_II_NAMESPACE_OPEN
 
 
 template <int dim, int spacedim>
-Boundary<dim, spacedim>::~Boundary ()
-{}
+Boundary<dim, spacedim>::~Boundary () = default;
 
 
 template <int dim, int spacedim>
@@ -187,8 +186,7 @@ get_line_support_points (const unsigned int n_intermediate_points) const
 
 
 template <int dim, int spacedim>
-StraightBoundary<dim, spacedim>::StraightBoundary ()
-{}
+StraightBoundary<dim, spacedim>::StraightBoundary () = default;
 
 
 template <int dim, int spacedim>
index b41bb529c74e5973a3b3c9cb764598a99b8c220e..0892432c831f82a05ed0956b932e82a562d7eda0 100644 (file)
@@ -87,8 +87,7 @@ namespace hp
   }
 
   template <int dim, int spacedim>
-  FECollection<dim,spacedim>::FECollection ()
-  {}
+  FECollection<dim,spacedim>::FECollection () = default;
 
 
 
index a0a6865f294ae6bcf655207a8ab060d28a9f9e26..3b3e1705ebe6008ca14050fffe73403af1fc8454 100644 (file)
@@ -24,8 +24,7 @@ namespace hp
 {
 
   template <int dim, int spacedim>
-  MappingCollection<dim,spacedim>::MappingCollection ()
-  {}
+  MappingCollection<dim,spacedim>::MappingCollection () = default;
 
 
 
index d51e74e5a5ee33bca4368101ebdf7b0239c80008..248e578261a0070ec0befb899e83c28e931f607c 100644 (file)
@@ -327,8 +327,7 @@ BlockSparsityPatternBase<SparsityPatternBase>::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;
 
 
 
index 3db63c4b1df17804cbe6f4370767dd08056e181a..1b77f41b347dfc4479df62a4651198ac5955229c 100644 (file)
@@ -91,8 +91,7 @@ ChunkSparsityPattern::ChunkSparsityPattern (
 
 
 
-ChunkSparsityPattern::~ChunkSparsityPattern ()
-{}
+ChunkSparsityPattern::~ChunkSparsityPattern () = default;
 
 
 
index 99a0037b2b4f722e8073c590f94ae9b1fcbd62d7..12d39c1b871170297918b813aeda48cbde691ece 100644 (file)
@@ -29,8 +29,7 @@ MatrixOut::Options::Options (const bool         show_absolute_values,
 
 
 
-MatrixOut::~MatrixOut ()
-{}
+MatrixOut::~MatrixOut () = default;
 
 
 
index 77f22484a5e39d896b6d75546a9da801c5df8914..b07a42d4a4822b019a53e92206baee055e17a24e 100644 (file)
@@ -24,12 +24,10 @@ namespace PETScWrappers
   namespace MPI
   {
 
-    BlockSparseMatrix::BlockSparseMatrix ()
-    {}
+    BlockSparseMatrix::BlockSparseMatrix () = default;
 
 
-    BlockSparseMatrix::~BlockSparseMatrix ()
-    {}
+    BlockSparseMatrix::~BlockSparseMatrix () = default;
 
 
     BlockSparseMatrix &
index 90039decba742d0a6ca51d50c09b5f9958d4e720..93e72acc4225951b826626b49c45a344eca540d4 100644 (file)
@@ -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,
index f0659b48ab54c519e80e57e010b48503c4e30fce..15f0d8752334a434255a434d95ad26e8ad816134 100644 (file)
@@ -49,8 +49,7 @@ namespace PETScWrappers
 
 
 
-  SolverBase::~SolverBase ()
-  {}
+  SolverBase::~SolverBase () = default;
 
 
 
index b01c280ef680c846142c0bf0ce686427bf931643..4533df2a72acbec7c89b4185aaeb922f087b9ce4 100644 (file)
@@ -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
index 0ddfe1813684552e3c0c6ab69e7d1fb8af0ee79a..26ba1d38baef2f2bc4c5674d44ffd8ee581417b5 100644 (file)
@@ -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;
 
 
 
index a9e0ff757ed7d6af6c4e321343b576a80f7feb59..5d6f636c7ed1abe9de20f51b76bcecf9069b112b 100644 (file)
@@ -68,8 +68,7 @@ namespace TrilinosWrappers
 
 
 
-    BlockVector::~BlockVector ()
-    {}
+    BlockVector::~BlockVector () = default;
 
 
 
index 5172593a14f539060269025bbd5e0303a2caa459..77569930652e627e884a0ba36bbca4e5f18ad1b1 100644 (file)
@@ -55,8 +55,7 @@ namespace TrilinosWrappers
 
 
 
-  PreconditionBase::~PreconditionBase()
-  {}
+  PreconditionBase::~PreconditionBase() = default;
 
 
 
index 82b2defe92dd94f63b27d699a1f04fb84f62368c..7cd95fca82371c2feee796727de16716ff2e56df 100644 (file)
@@ -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;
 
 
 
index 24ee2f794d5fb7a7257d2e26dff22370a0f6e26d..2aa484d0768120e0105727d9cf117f7cc9ce7db7 100644 (file)
@@ -356,8 +356,7 @@ namespace TrilinosWrappers
 
 
 
-  SparseMatrix::~SparseMatrix ()
-  {}
+  SparseMatrix::~SparseMatrix () = default;
 
 
 
@@ -2701,8 +2700,7 @@ namespace TrilinosWrappers
 
 
       // Destructor
-      TrilinosPayload::~TrilinosPayload ()
-      { }
+      TrilinosPayload::~TrilinosPayload () = default;
 
 
 
index 0776cd0b926cc8afc107d8d82aad2e7f97527e20..5e09df631acf30340d614730e5082f3e162a0025 100644 (file)
@@ -221,8 +221,7 @@ namespace TrilinosWrappers
 
 
 
-  SparsityPattern::~SparsityPattern ()
-  {}
+  SparsityPattern::~SparsityPattern () = default;
 
 
 
index c9e30fd3ab04ba5cb07bd498b29af75ec373af3d..46251ade0772d116a83d53fc29c014f05ca5a375 100644 (file)
@@ -72,8 +72,7 @@ namespace MeshWorker
 
 
   template <int dim, int spacedim, typename number>
-  LocalIntegrator<dim, spacedim, number>::~LocalIntegrator ()
-  {}
+  LocalIntegrator<dim, spacedim, number>::~LocalIntegrator () = default;
 
   template <int dim, int spacedim, typename number>
   void
index efb63321dd4ec5e864265bc4a14e7a2dbb4a4aef..b4e6bab9d4f819d5065d8916290b7b70237a5f0c 100644 (file)
@@ -28,18 +28,15 @@ DEAL_II_NAMESPACE_OPEN
 
 
 template <typename VectorType>
-MGTransferBase<VectorType>::~MGTransferBase()
-{}
+MGTransferBase<VectorType>::~MGTransferBase() = default;
 
 
 template <typename VectorType>
-MGMatrixBase<VectorType>::~MGMatrixBase()
-{}
+MGMatrixBase<VectorType>::~MGMatrixBase() = default;
 
 
 template <typename VectorType>
-MGSmootherBase<VectorType>::~MGSmootherBase()
-{}
+MGSmootherBase<VectorType>::~MGSmootherBase() = default;
 
 
 template <typename VectorType>
@@ -54,8 +51,7 @@ MGSmootherBase<VectorType>::apply (const unsigned int level,
 
 
 template <typename VectorType>
-MGCoarseGridBase<VectorType>::~MGCoarseGridBase()
-{}
+MGCoarseGridBase<VectorType>::~MGCoarseGridBase() = default;
 
 
 // Explicit instantiations
index 4ebfdc44921e032437b5f99e2948c681098afa0d..0e9c7583fc20bd7964806b805471bdb68e0ffc08 100644 (file)
@@ -59,8 +59,7 @@ MGTransferMatrixFree<dim,Number>::MGTransferMatrixFree (const MGConstrainedDoFs
 
 
 template <int dim, typename Number>
-MGTransferMatrixFree<dim,Number>::~MGTransferMatrixFree ()
-{}
+MGTransferMatrixFree<dim,Number>::~MGTransferMatrixFree () = default;
 
 
 
@@ -554,8 +553,7 @@ MGTransferMatrixFree<dim,Number>::memory_consumption() const
 
 
 template <int dim, typename Number>
-MGTransferBlockMatrixFree<dim,Number>::MGTransferBlockMatrixFree ()
-{}
+MGTransferBlockMatrixFree<dim,Number>::MGTransferBlockMatrixFree () = default;
 
 
 
@@ -569,8 +567,7 @@ MGTransferBlockMatrixFree<dim,Number>::MGTransferBlockMatrixFree (const MGConstr
 
 
 template <int dim, typename Number>
-MGTransferBlockMatrixFree<dim,Number>::~MGTransferBlockMatrixFree ()
-{}
+MGTransferBlockMatrixFree<dim,Number>::~MGTransferBlockMatrixFree () = default;
 
 
 
index 098eac5d3d70df99923e7f99d225d754fc84a115..1e2a68b185132926f0a34becd95173390aa63ea4 100644 (file)
@@ -41,8 +41,7 @@ DEAL_II_NAMESPACE_OPEN
 
 
 template <typename VectorType>
-MGTransferPrebuilt<VectorType>::MGTransferPrebuilt ()
-{}
+MGTransferPrebuilt<VectorType>::MGTransferPrebuilt () = default;
 
 
 
@@ -63,8 +62,7 @@ MGTransferPrebuilt<VectorType>::MGTransferPrebuilt (const ConstraintMatrix &/*c*
 
 
 template <typename VectorType>
-MGTransferPrebuilt<VectorType>::~MGTransferPrebuilt ()
-{}
+MGTransferPrebuilt<VectorType>::~MGTransferPrebuilt () = default;
 
 
 
index b85f72e930d68babca900a1278500eba5f563d3a..65c56843c028011838afae7427ba2ec4832c35bf 100644 (file)
@@ -215,8 +215,7 @@ MGTransferSelect<number>::MGTransferSelect (const ConstraintMatrix &c)
 {}
 
 template <typename number>
-MGTransferSelect<number>::~MGTransferSelect ()
-{}
+MGTransferSelect<number>::~MGTransferSelect () = default;
 
 
 template <typename number>
@@ -280,8 +279,7 @@ MGTransferBlockSelect<number>::MGTransferBlockSelect (const ConstraintMatrix &/*
 
 
 template <typename number>
-MGTransferBlockSelect<number>::~MGTransferBlockSelect ()
-{}
+MGTransferBlockSelect<number>::~MGTransferBlockSelect () = default;
 
 
 
index 46aaa609055cf960cf62ece408c280a09d35cd5a..eab0961801d5c3dab447c52fa21640a024cf61bc 100644 (file)
@@ -42,8 +42,7 @@ DataOutStack<dim,spacedim,DoFHandlerType>::DataVector::memory_consumption () con
 
 
 template <int dim, int spacedim, typename DoFHandlerType>
-DataOutStack<dim,spacedim,DoFHandlerType>::~DataOutStack ()
-{}
+DataOutStack<dim,spacedim,DoFHandlerType>::~DataOutStack () = default;
 
 
 template <int dim, int spacedim, typename DoFHandlerType>
index 67678d14df1660998910c9539b20fbd376f51ff9..1ded8ae43462ddef035de3567386d4855e903274 100644 (file)
@@ -22,8 +22,7 @@ DEAL_II_NAMESPACE_OPEN
 // -------------------------- DataPostprocessor ---------------------------
 
 template <int dim>
-DataPostprocessor<dim>::~DataPostprocessor()
-{}
+DataPostprocessor<dim>::~DataPostprocessor() = default;
 
 
 
index 4016237ca56af52eaf3859a4e06e9ea45dd0460f..8866786410335eeb187722dc1ccdd5830365482a 100644 (file)
@@ -735,12 +735,12 @@ namespace DerivativeApproximation
     {
       struct Scratch
       {
-        Scratch() {}
+        Scratch() = default;
       };
 
       struct CopyData
       {
-        CopyData() {}
+        CopyData() = default;
       };
     }
   }
index bee615228c57779f57025c10bb5be64d06d72ea9..bb979f04c7922a082201b480fe3b0b185665d98c 100644 (file)
@@ -264,8 +264,7 @@ TimeStepBase::TimeStepBase (const double time) :
 
 
 
-TimeStepBase::~TimeStepBase ()
-{}
+TimeStepBase::~TimeStepBase () = default;
 
 
 

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.