]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Use '= default' for some constructors. 4377/head
authorDavid Wells <wellsd2@rpi.edu>
Fri, 12 May 2017 00:16:44 +0000 (20:16 -0400)
committerDavid Wells <wellsd2@rpi.edu>
Fri, 12 May 2017 00:16:44 +0000 (20:16 -0400)
29 files changed:
include/deal.II/algorithms/any_data.h
include/deal.II/base/point.h
include/deal.II/base/symmetric_tensor.h
include/deal.II/base/table.h
include/deal.II/base/thread_management.h
include/deal.II/fe/block_mask.h
include/deal.II/fe/component_mask.h
include/deal.II/grid/tria_accessor.h
include/deal.II/hp/q_collection.h
include/deal.II/lac/block_matrix_base.h
include/deal.II/lac/block_sparse_matrix.h
include/deal.II/lac/block_sparse_matrix.templates.h
include/deal.II/lac/block_sparse_matrix_ez.h
include/deal.II/lac/block_sparse_matrix_ez.templates.h
include/deal.II/lac/block_vector_base.h
include/deal.II/lac/diagonal_matrix.h
include/deal.II/lac/dynamic_sparsity_pattern.h
include/deal.II/lac/la_vector.h
include/deal.II/lac/petsc_parallel_block_vector.h
include/deal.II/lac/solver_selector.h
include/deal.II/lac/trilinos_parallel_block_vector.h
include/deal.II/lac/trilinos_precondition.h
include/deal.II/lac/vector_memory.h
include/deal.II/meshworker/dof_info.h
include/deal.II/meshworker/dof_info.templates.h
include/deal.II/meshworker/vector_selector.h
include/deal.II/meshworker/vector_selector.templates.h
include/deal.II/multigrid/mg_coarse.h
include/deal.II/multigrid/mg_matrix.h

index 23a3027b326ece0b19d027ea8bdbef378ab2a96d..e7bca13272233d9d5227d10998aebb7642363195 100644 (file)
@@ -37,7 +37,7 @@ class AnyData :
 {
 public:
   /// Default constructor for empty object
-  AnyData();
+  AnyData() = default;
 
   /// Number of stored data objects.
   unsigned int size() const;
@@ -194,11 +194,6 @@ private:
 };
 
 
-inline
-AnyData::AnyData()
-{}
-
-
 unsigned int
 inline
 AnyData::size () const
@@ -470,13 +465,3 @@ void AnyData::list(StreamType &os) const
 DEAL_II_NAMESPACE_CLOSE
 
 #endif
-
-
-
-
-
-
-
-
-
-
index 8048390ca19beaf9c11a7d409f2475588e629900..09578ff7938a7d005933e4b9a9fff8fbb25d224c 100644 (file)
@@ -93,7 +93,7 @@ public:
    * Standard constructor. Creates an object that corresponds to the origin,
    * i.e., all coordinates are set to zero.
    */
-  Point ();
+  Point () = default;
 
   /**
    * Convert a tensor to a point.
@@ -249,13 +249,6 @@ public:
 
 #ifndef DOXYGEN
 
-template <int dim, typename Number>
-inline
-Point<dim,Number>::Point ()
-{}
-
-
-
 template <int dim, typename Number>
 inline
 Point<dim,Number>::Point (const Tensor<1,dim,Number> &t)
index c685ef65a90930201bc880dfe3bf590d6b01bc24..76897e81bd7b306fb794dd26f0cff1b955bedb37 100644 (file)
@@ -529,7 +529,7 @@ public:
   /**
    * Default constructor. Creates a tensor with all entries equal to zero.
    */
-  SymmetricTensor ();
+  SymmetricTensor () = default;
 
   /**
    * Constructor. Generate a symmetric tensor from a general one. Assumes that
@@ -922,13 +922,6 @@ namespace internal
 
 
 
-template <int rank, int dim, typename Number>
-inline
-SymmetricTensor<rank,dim,Number>::SymmetricTensor ()
-{}
-
-
-
 template <int rank, int dim, typename Number>
 inline
 SymmetricTensor<rank,dim,Number>::SymmetricTensor (const Tensor<2,dim,Number> &t)
index 4d98edf54158805972dccfa24fb4beddc174212e..8a33ce74056ed535131b971239587fc60aec4a02 100644 (file)
@@ -414,7 +414,7 @@ public:
   /**
    * Default constructor. Set all dimensions to zero.
    */
-  TableBase ();
+  TableBase () = default;
 
   /**
    * Constructor. Initialize the array with the given dimensions in each index
@@ -700,7 +700,7 @@ public:
   /**
    * Default constructor. Set all dimensions to zero.
    */
-  Table ();
+  Table () = default;
 
   /**
    * Constructor. Pass down the given dimension to the base class.
@@ -819,7 +819,7 @@ public:
   /**
    * Default constructor. Set all dimensions to zero.
    */
-  Table ();
+  Table () = default;
 
   /**
    * Constructor. Pass down the given dimensions to the base class.
@@ -1004,7 +1004,7 @@ public:
   /**
    * Default constructor. Set all dimensions to zero.
    */
-  Table ();
+  Table () = default;
 
   /**
    * Constructor. Pass down the given dimensions to the base class.
@@ -1138,7 +1138,7 @@ public:
   /**
    * Default constructor. Set all dimensions to zero.
    */
-  Table ();
+  Table () = default;
 
   /**
    * Constructor. Pass down the given dimensions to the base class.
@@ -1231,7 +1231,7 @@ public:
   /**
    * Default constructor. Set all dimensions to zero.
    */
-  Table ();
+  Table () = default;
 
   /**
    * Constructor. Pass down the given dimensions to the base class.
@@ -1325,7 +1325,7 @@ public:
   /**
    * Default constructor. Set all dimensions to zero.
    */
-  Table ();
+  Table () = default;
 
   /**
    * Constructor. Pass down the given dimensions to the base class.
@@ -1421,7 +1421,7 @@ public:
   /**
    * Default constructor. Set all dimensions to zero.
    */
-  Table ();
+  Table () = default;
 
   /**
    * Constructor. Pass down the given dimensions to the base class.
@@ -1524,7 +1524,7 @@ public:
   /**
    * Default constructor. Set all dimensions to zero.
    */
-  TransposeTable ();
+  TransposeTable () = default;
 
   /**
    * Constructor. Pass down the given dimensions to the base class.
@@ -1610,12 +1610,6 @@ protected:
 
 #ifndef DOXYGEN
 
-template <int N, typename T>
-TableBase<N,T>::TableBase ()
-{}
-
-
-
 template <int N, typename T>
 TableBase<N,T>::TableBase (const TableIndices<N> &sizes)
 {
@@ -2172,13 +2166,6 @@ TableBase<N,T>::el (const TableIndices<N> &indices)
 
 
 
-template <typename T>
-inline
-Table<1,T>::Table ()
-{}
-
-
-
 template <typename T>
 inline
 Table<1,T>::Table (const unsigned int size)
@@ -2271,11 +2258,6 @@ Table<1,T>::operator () (const TableIndices<1> &indices)
 
 //---------------------------------------------------------------------------
 
-template <typename T>
-inline
-Table<2,T>::Table ()
-{}
-
 
 
 template <typename T>
@@ -2434,14 +2416,6 @@ Table<2,T>::n_cols () const
 
 
 //---------------------------------------------------------------------------
-
-template <typename T>
-inline
-TransposeTable<T>::TransposeTable ()
-{}
-
-
-
 template <typename T>
 inline
 TransposeTable<T>::TransposeTable (const unsigned int size1,
@@ -2539,12 +2513,6 @@ TransposeTable<T>::n_cols () const
 //---------------------------------------------------------------------------
 
 
-template <typename T>
-inline
-Table<3,T>::Table ()
-{}
-
-
 
 template <typename T>
 inline
@@ -2663,13 +2631,6 @@ Table<3,T>::operator () (const TableIndices<3> &indices)
 
 
 
-template <typename T>
-inline
-Table<4,T>::Table ()
-{}
-
-
-
 template <typename T>
 inline
 Table<4,T>::Table (const unsigned int size1,
@@ -2782,13 +2743,6 @@ Table<4,T>::operator () (const TableIndices<4> &indices)
 
 
 
-template <typename T>
-inline
-Table<5,T>::Table ()
-{}
-
-
-
 template <typename T>
 inline
 Table<5,T>::Table (const unsigned int size1,
@@ -2912,13 +2866,6 @@ Table<5,T>::operator () (const TableIndices<5> &indices)
 
 
 
-template <typename T>
-inline
-Table<6,T>::Table ()
-{}
-
-
-
 template <typename T>
 inline
 Table<6,T>::Table (const unsigned int size1,
@@ -3053,13 +3000,6 @@ Table<6,T>::operator () (const TableIndices<6> &indices)
 
 
 
-template <typename T>
-inline
-Table<7,T>::Table ()
-{}
-
-
-
 template <typename T>
 inline
 Table<7,T>::Table (const unsigned int size1,
index a1c48bc546e67790596cf54c5f0ec7b9f3b3676f..5ef206d7aaacccf33e7c29006130f73e4d20470e 100644 (file)
@@ -291,8 +291,7 @@ namespace Threads
     /**
      * Default constructor.
      */
-    Mutex ()
-    {}
+    Mutex () = default;
 
     /**
      * Copy constructor. As discussed in this class's documentation, no state
@@ -1223,7 +1222,7 @@ namespace Threads
      * this way, except for assigning it a thread object that holds data
      * created by the new_thread() functions.
      */
-    Thread () {}
+    Thread () = default;
 
     /**
      * Copy constructor.
@@ -3103,7 +3102,7 @@ namespace Threads
      * @post Using this constructor leaves the object in an unjoinable state,
      * i.e., joinable() will return false.
      */
-    Task () {}
+    Task () = default;
 
     /**
      * Join the task represented by this object, i.e. wait for it to finish.
index 33b79728bfc8e2a9b361988b0e8c708db22e7bdc..f436bd967c912d9a24bdae49d0bebc0854a0f1de 100644 (file)
@@ -77,7 +77,7 @@ public:
    * constructor results in a block mask that always returns <code>true</code>
    * whenever asked whether a block is selected.
    */
-  BlockMask ();
+  BlockMask () = default;
 
   /**
    * Initialize an object of this type with a set of selected blocks specified
@@ -230,11 +230,6 @@ std::ostream &operator << (std::ostream &out,
 
 // -------------------- inline functions ---------------------
 
-inline
-BlockMask::BlockMask()
-{}
-
-
 inline
 BlockMask::BlockMask(const std::vector<bool> &block_mask)
   :
index 018990f519a9186f84b9c71c2a6892a613b1dfb1..50c3822dbce24d3f71a29acd04828b5a8a75d459 100644 (file)
@@ -73,7 +73,7 @@ public:
    * calling this constructor results in a component mask that always returns
    * <code>true</code> whenever asked whether a component is selected.
    */
-  ComponentMask ();
+  ComponentMask () = default;
 
   /**
    * Initialize an object of this type with a set of selected components
@@ -238,11 +238,6 @@ std::ostream &operator << (std::ostream &out,
 
 // -------------------- inline functions ---------------------
 
-inline
-ComponentMask::ComponentMask()
-{}
-
-
 inline
 ComponentMask::ComponentMask(const std::vector<bool> &component_mask)
   :
index 3cb868ad464e78d42080c1263275aeef59c6f2a4..d3f8b04d58437f678794bad5616827eeb9ecfe4f 100644 (file)
@@ -64,8 +64,7 @@ namespace internal
         /**
          * Default constructor.
          */
-        type ()
-        {}
+        type () = default;
 
         /**
          * Dummy constructor. Only level zero is allowed.
index ebdd02c2f20f7bb284cbc9ad0ebfd63a2def3369..2dde30b5c7cbcd6311725740534ce05ee67bf4e1 100644 (file)
@@ -50,7 +50,7 @@ namespace hp
      * Default constructor. Leads to an empty collection that can later be
      * filled using push_back().
      */
-    QCollection ();
+    QCollection () = default;
 
     /**
      * Conversion constructor. This constructor creates a QCollection from a
@@ -176,13 +176,6 @@ namespace hp
 
 
 
-  template <int dim>
-  inline
-  QCollection<dim>::QCollection ()
-  {}
-
-
-
   template <int dim>
   inline
   QCollection<dim>::QCollection (const Quadrature<dim> &quadrature)
index e775be4483f33eea4e153967da576e944dae6a21..2171ae11dd7093624bc4b051724afbb44cddba95 100644 (file)
@@ -369,7 +369,7 @@ public:
   /**
    * Default constructor.
    */
-  BlockMatrixBase ();
+  BlockMatrixBase () = default;
 
   /**
    * Destructor.
@@ -1485,12 +1485,6 @@ namespace BlockMatrixIterators
 
 //---------------------------------------------------------------------------
 
-
-template <typename MatrixType>
-inline
-BlockMatrixBase<MatrixType>::BlockMatrixBase ()
-{}
-
 template <typename MatrixType>
 inline
 BlockMatrixBase<MatrixType>::~BlockMatrixBase ()
index 4297697e2e0849e110da0e550f2b57f32639bebc..c9eb6f8c20f3f375dac97c3bbc7a21769806655d 100644 (file)
@@ -87,7 +87,7 @@ public:
    * reinit(BlockSparsityPattern). The number of blocks per row and column are
    * then determined by that function.
    */
-  BlockSparseMatrix ();
+  BlockSparseMatrix () = default;
 
   /**
    * Constructor. Takes the given matrix sparsity structure to represent the
index de2d415560558c1be8c39207cf7f775b52da2437..e3e2d830ad3ddd6eed8d4ff17a3d4dc3a8e2da84 100644 (file)
 
 DEAL_II_NAMESPACE_OPEN
 
-
-template <typename number>
-BlockSparseMatrix<number>::BlockSparseMatrix ()
-{}
-
-
-
 template <typename number>
 BlockSparseMatrix<number>::
 BlockSparseMatrix (const BlockSparsityPattern &sparsity)
index 1ef96a9ed5bb727feb7c2a8e1a3a2d42990bcd3f..6c2b2b294135c272a4732040925d61a55edbb8fc 100644 (file)
@@ -60,7 +60,7 @@ public:
   /**
    * Default constructor. The result is an empty object with zero dimensions.
    */
-  BlockSparseMatrixEZ ();
+  BlockSparseMatrixEZ () = default;
 
   /**
    * Constructor setting up an object with given number of block rows and
index 1ce5c06cfe4e0aed1a8a6c2d9da1cde47153cba0..6e3dabba643c9c11cab0753f99162cac3e6e2e2b 100644 (file)
 
 DEAL_II_NAMESPACE_OPEN
 
-
-template <typename number>
-BlockSparseMatrixEZ<number>::BlockSparseMatrixEZ ()
-{}
-
-
-
 template <typename number>
 BlockSparseMatrixEZ<number>::
 BlockSparseMatrixEZ (const unsigned int rows,
index 8b9bfa18955c6256b4d1936abb10239c47c84d87..26ba82b8218a7161e955deebfd7a2a9d02482650 100644 (file)
@@ -551,7 +551,7 @@ public:
   /**
    * Default constructor.
    */
-  BlockVectorBase ();
+  BlockVectorBase () = default;
 
   /**
    * Copy constructor.
@@ -1453,13 +1453,6 @@ namespace internal
 
 
 
-template <class VectorType>
-inline
-BlockVectorBase<VectorType>::BlockVectorBase ()
-{}
-
-
-
 template <class VectorType>
 inline
 std::size_t
index d745c4c7b0ef422e27ae68bac7478b3088d257ee..2e80b0b39860f55f5c5952cd38267b7a6e2cc509 100644 (file)
@@ -52,7 +52,7 @@ public:
   /**
    * Constructor.
    */
-  DiagonalMatrix();
+  DiagonalMatrix() = default;
 
   /**
    * Initialize with a given vector by copying the content of the vector
@@ -194,14 +194,6 @@ private:
 
 #ifndef DOXYGEN
 
-template <typename VectorType>
-DiagonalMatrix<VectorType>::DiagonalMatrix()
-  :
-  Subscriptor()
-{}
-
-
-
 template <typename VectorType>
 void
 DiagonalMatrix<VectorType>::clear()
index 2b08664953dd442e229af4d81f1cbf47a6dc3857..c92cbff6061cdd1dbe3e080835313deb1f00d250 100644 (file)
@@ -598,11 +598,6 @@ private:
      */
     std::vector<size_type> entries;
 
-    /**
-     * Constructor.
-     */
-    Line ();
-
     /**
      * Add the given column number to this line.
      */
@@ -986,12 +981,6 @@ DynamicSparsityPattern::add_entries (const size_type row,
 
 
 
-inline
-DynamicSparsityPattern::Line::Line ()
-{}
-
-
-
 inline
 types::global_dof_index
 DynamicSparsityPattern::row_length (const size_type row) const
index 380954c4344205d35cd1bc0b86c24300dd3fe8a5..82faf7f0837e4d2db549f8606daa0e76bc60aa0a 100644 (file)
@@ -68,7 +68,7 @@ namespace LinearAlgebra
     /**
      * Constructor. Create a vector of dimension zero.
      */
-    Vector();
+    Vector() = default;
 
     /**
      * Copy constructor. Sets the dimension to that of the given vector and
@@ -339,12 +339,6 @@ namespace LinearAlgebra
   /*@}*/
   /*----------------------- Inline functions ----------------------------------*/
 
-  template <typename Number>
-  inline
-  Vector<Number>::Vector() {}
-
-
-
   template <typename Number>
   inline
   Vector<Number>::Vector(const Vector<Number> &V)
index 8c5731900b4e1e7cdddff0ed9f92f886b6e03b89..fcdf70db9f0a226c93e0a4ef4290458e3d5fcb96 100644 (file)
@@ -87,7 +87,7 @@ namespace PETScWrappers
       /**
        * Default constructor. Generate an empty vector without any blocks.
        */
-      BlockVector ();
+      BlockVector () = default;
 
       /**
        * Constructor. Generate a block vector with @p n_blocks blocks, each of
@@ -281,13 +281,6 @@ namespace PETScWrappers
 
     /*----------------------- Inline functions ----------------------------------*/
 
-
-    inline
-    BlockVector::BlockVector ()
-    {}
-
-
-
     inline
     BlockVector::BlockVector (const unsigned int  n_blocks,
                               const MPI_Comm     &communicator,
index 383e083053df94165898b17e11bd27558f6a83a6..0c78fc44c7c8dd3b2c003c3d30301de2146d93e2 100644 (file)
@@ -106,7 +106,7 @@ public:
   /**
    * Constructor, filling in default values
    */
-  SolverSelector ();
+  SolverSelector () = default;
 
   /**
    * Destructor
@@ -242,11 +242,6 @@ private:
 /* --------------------- Inline and template functions ------------------- */
 
 
-template <typename VectorType>
-SolverSelector<VectorType>::SolverSelector()
-{}
-
-
 template <typename VectorType>
 SolverSelector<VectorType>::~SolverSelector()
 {}
index 81b22369a876bb6c622885401c68cde9706537d9..6d2fd911a2830dbe1ef2576a7d87087ab6ba94f7 100644 (file)
@@ -96,7 +96,7 @@ namespace TrilinosWrappers
       /**
        * Default constructor. Generate an empty vector without any blocks.
        */
-      BlockVector ();
+      BlockVector () = default;
 
       /**
        * Constructor. Generate a block vector with as many blocks as there are
@@ -306,14 +306,6 @@ namespace TrilinosWrappers
 
 
     /*----------------------- Inline functions ----------------------------------*/
-
-
-    inline
-    BlockVector::BlockVector ()
-    {}
-
-
-
     inline
     BlockVector::BlockVector (const std::vector<IndexSet> &parallel_partitioning,
                               const MPI_Comm              &communicator)
index f3ff0283a2ab6a22fbda15d8e7c2c302749156db..0822c5b9b81aa9eb586e60d1ba0579bea06dd31c 100644 (file)
@@ -1863,12 +1863,7 @@ namespace TrilinosWrappers
      * preconditioner to be handed to a smoother.  This does nothing.
      */
     struct AdditionalData
-    {
-      /**
-       * Constructor.
-       */
-      AdditionalData () {}
-    };
+    {};
 
     /**
      * The matrix argument is ignored and here just for compatibility with more
index f899c237d932d4857accd0cf470de1d2056263be..9968a50b96f10d188ccb415d0cb9c3e5fb90496f 100644 (file)
@@ -176,7 +176,7 @@ public:
   /**
    * Constructor.
    */
-  PrimitiveVectorMemory () {}
+  PrimitiveVectorMemory () = default;
 
   /**
    * Return a pointer to a new vector. The number of elements or their
index 6daf750343eabf7d1995a4b8fba3bf4f2096b511..3de939b51b9a5ba087d6abcd94c82ec33b8710a1 100644 (file)
@@ -171,7 +171,7 @@ namespace MeshWorker
      * constructor is not recommended, but it is needed for the arrays in
      * DoFInfoBox.
      */
-    DoFInfo ();
+    DoFInfo () = default;
 
     /// Set up local block indices
     void set_block_indices ();
index ee9b9c1cd52d6966f9d382854f95811d524dcedd..2a11485db79b93ad461ef8fa657fd51510357063 100644 (file)
@@ -39,10 +39,6 @@ namespace MeshWorker
   }
 
 
-  template <int dim, int spacedim, typename number>
-  DoFInfo<dim,spacedim,number>::DoFInfo()
-  {}
-
 
   template <int dim, int spacedim, typename number>
   void
index 1917b9d5f1ae2af07355b2436e7731cd8ff32b79..d0100eba5d1016916d61e617f060e3b4fdbfa237 100644 (file)
@@ -293,7 +293,8 @@ namespace MeshWorker
     /**
      * Constructor.
      */
-    VectorData();
+    VectorData() = default;
+
     /**
      * Constructor using a prefilled VectorSelector
      */
@@ -359,7 +360,7 @@ namespace MeshWorker
     /**
      * Constructor.
      */
-    MGVectorData();
+    MGVectorData() = default;
 
     /**
      * Constructor using a prefilled VectorSelector
index 24c73a890044aa676238c44a95dc6978dd7c31a9..08781551bea25e2e1fb1681072f499b037271617 100644 (file)
@@ -88,11 +88,6 @@ namespace MeshWorker
 
 //----------------------------------------------------------------------//
 
-  template <typename VectorType, int dim, int spacedim>
-  VectorData<VectorType, dim, spacedim>::VectorData()
-  {}
-
-
   template <typename VectorType, int dim, int spacedim>
   VectorData<VectorType, dim, spacedim>::VectorData(const VectorSelector &s)
     :
@@ -171,11 +166,6 @@ namespace MeshWorker
 
 //----------------------------------------------------------------------//
 
-  template <typename VectorType, int dim, int spacedim>
-  MGVectorData<VectorType, dim, spacedim>::MGVectorData()
-  {}
-
-
   template <typename VectorType, int dim, int spacedim>
   MGVectorData<VectorType, dim, spacedim>::MGVectorData(const VectorSelector &s)
     :
index 0fa4ed65559dd5385cbb194cde44dfc3d8490e7a..b14c4c74c16e53634b70495e0633a6cbff47cd3f 100644 (file)
@@ -278,7 +278,7 @@ public:
   /**
    * Constructor leaving an uninitialized object.
    */
-  MGCoarseGridSVD ();
+  MGCoarseGridSVD () = default;
 
   /**
    * Initialize for a new matrix. This resets the dimensions to the
@@ -549,11 +549,6 @@ MGCoarseGridHouseholder<number, VectorType>::operator() (const unsigned int /*le
 
 //---------------------------------------------------------------------------
 
-template<typename number, class VectorType>
-inline
-MGCoarseGridSVD<number, VectorType>::MGCoarseGridSVD()
-{}
-
 
 
 template<typename number, class VectorType>
index 6c80f425e784939102c9c6efe85418af041cabbb..ec6c7b7eac1e1e4580ce81026710acdb2eaabcfb 100644 (file)
@@ -47,7 +47,7 @@ namespace mg
     /**
      * Default constructor for an empty object.
      */
-    Matrix();
+    Matrix() = default;
 
     /**
      * Constructor setting up pointers to the matrices in <tt>M</tt> by
@@ -195,13 +195,6 @@ namespace mg
 
 
 
-  template <typename VectorType>
-  inline
-  Matrix<VectorType>::Matrix ()
-  {}
-
-
-
   template <typename VectorType>
   inline
   const PointerMatrixBase<VectorType> &

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.