]> https://gitweb.dealii.org/ - dealii.git/commitdiff
modernize-use-equals-default
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Tue, 15 Jan 2019 23:39:17 +0000 (00:39 +0100)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Sat, 19 Jan 2019 22:37:59 +0000 (23:37 +0100)
19 files changed:
contrib/utilities/run_clang_tidy.sh
examples/step-30/step-30.cc
examples/step-44/step-44.cc
examples/step-54/step-54.cc
include/deal.II/base/derivative_form.h
include/deal.II/base/index_set.h
include/deal.II/base/point.h
include/deal.II/base/quadrature_point_data.h
include/deal.II/base/tensor.h
include/deal.II/grid/tria.h
include/deal.II/lac/solver_bicgstab.h
include/deal.II/lac/solver_selector.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/matrix_free/mapping_info.h
include/deal.II/matrix_free/mapping_info.templates.h
include/deal.II/matrix_free/task_info.h
include/deal.II/particles/particle_handler.h
source/grid/tria.cc
source/particles/particle_handler.cc

index fb8ec7ed788337c71ff5b4ce9a62d5b69ca06663..2277ff4320248e7e13959a11db94252491a85007 100755 (executable)
@@ -52,6 +52,7 @@ CHECKS="-*,
         modernize-deprecated-headers,
         modernize-redundant-void-arg,
         modernize-use-emplace,
+        modernize-use-equals-default,
         modernize-use-nullptr,
         modernize-use-using,
         mpi-*,
index 10700b9fcc6dde210083e8b55cc2d4e14c4f04f0..0bdf2a3028566d45512706b937f8dba4b37b4181 100644 (file)
@@ -80,8 +80,6 @@ namespace Step30
   class Beta
   {
   public:
-    Beta()
-    {}
     void value_list(const std::vector<Point<dim>> &points,
                     std::vector<Point<dim>> &      values) const;
   };
index 249b66d05a05e221beff087c262fe59f29bb4afc..1cbc8c819407e20ac282d4cfb515a20320f892d3 100644 (file)
@@ -453,8 +453,7 @@ namespace Step44
       , delta_t(delta_t)
     {}
 
-    virtual ~Time()
-    {}
+    virtual ~Time() = default;
 
     double current() const
     {
@@ -530,9 +529,6 @@ namespace Step44
       Assert(kappa > 0, ExcInternalError());
     }
 
-    ~Material_Compressible_Neo_Hook_Three_Field()
-    {}
-
     // We update the material model with various deformation dependent data
     // based on $F$ and the pressure $\widetilde{p}$ and dilatation
     // $\widetilde{J}$, and at the end of the function include a physical
@@ -693,8 +689,7 @@ namespace Step44
       , Jc(SymmetricTensor<4, dim>())
     {}
 
-    virtual ~PointHistory()
-    {}
+    virtual ~PointHistory() = default;
 
     // The first function is used to create a material object and to
     // initialize all tensors correctly: The second one updates the stored
index 4fab36bfb3498058e13b79a61922b00377a7961f..7ddbbd372bf60f3534c40fc0d65e8a881d3408ee 100644 (file)
@@ -82,9 +82,6 @@ namespace Step54
       const std::string &  output_filename,
       const ProjectionType surface_projection_kind = NormalProjection);
 
-
-    ~TriangulationOnCAD();
-
     void run();
 
   private:
@@ -123,10 +120,6 @@ namespace Step54
     , surface_projection_kind(surface_projection_kind)
   {}
 
-  TriangulationOnCAD::~TriangulationOnCAD()
-  {}
-
-
 
   // @sect4{TriangulationOnCAD::read_domain}
 
index e4c6ccd23bc4ce0879fd077e8d7e7003f4c93cad..016540eeada52824d8b7b58af8c66cf3b115900e 100644 (file)
@@ -59,7 +59,7 @@ public:
   /**
    * Constructor. Initialize all entries to zero.
    */
-  DerivativeForm();
+  DerivativeForm() = default;
 
   /**
    * Constructor from a tensor.
@@ -166,18 +166,6 @@ private:
 
 #ifndef DOXYGEN
 
-
-
-template <int order, int dim, int spacedim, typename Number>
-inline DerivativeForm<order, dim, spacedim, Number>::DerivativeForm()
-{
-  // default constructor. not specifying an initializer list calls
-  // the default constructor of the subobjects, which initialize them
-  // selves. therefore, the tensor array  is set to zero this way
-}
-
-
-
 template <int order, int dim, int spacedim, typename Number>
 inline DerivativeForm<order, dim, spacedim, Number>::DerivativeForm(
   const Tensor<order + 1, dim, Number> &T)
index f2ec3322bef383383bda423ee4d842475d30580d..439775a1309ffe0419b126cc6519554a5e47fe0c 100644 (file)
@@ -592,13 +592,13 @@ public:
     /**
      * Copy constructor from @p other iterator.
      */
-    IntervalIterator(const IntervalIterator &other);
+    IntervalIterator(const IntervalIterator &other) = default;
 
     /**
      * Assignment of another iterator.
      */
     IntervalIterator &
-    operator=(const IntervalIterator &other);
+    operator=(const IntervalIterator &other) = default;
 
     /**
      * Prefix increment.
@@ -1136,22 +1136,6 @@ inline IndexSet::IntervalIterator::IntervalIterator(const IndexSet *idxset)
 
 
 
-inline IndexSet::IntervalIterator::IntervalIterator(
-  const IndexSet::IntervalIterator &other)
-  : accessor(other.accessor)
-{}
-
-
-
-inline IndexSet::IntervalIterator &
-IndexSet::IntervalIterator::operator=(const IntervalIterator &other)
-{
-  accessor = other.accessor;
-  return *this;
-}
-
-
-
 inline IndexSet::IntervalIterator &
 IndexSet::IntervalIterator::operator++()
 {
index 8bae4ecb034452bdb6263040cc35d85b7c8930a8..3fd26b46ce950f19883a1620c1b9fa8c987c3033 100644 (file)
@@ -281,7 +281,7 @@ public:
 // At least clang-3.7 requires us to have a user-defined constructor
 // and we can't use 'Point<dim,Number>::Point () = default' here.
 template <int dim, typename Number>
-inline Point<dim, Number>::Point()
+inline Point<dim, Number>::Point() // NOLINT
 {}
 
 
index 71ae9104f77a41eaeb5d85ed80b9515b31875144..f3b81c3859c6f73345f2c98da4dab4b40e34d11a 100644 (file)
@@ -371,11 +371,6 @@ namespace parallel
                                        const Quadrature<dim> &mass_quadrature,
                                        const Quadrature<dim> &data_quadrature);
 
-      /**
-       * Destructor.
-       */
-      ~ContinuousQuadratureDataTransfer();
-
       /**
        * Prepare for coarsening and refinement of a triangulation @p tria .
        * @p data_storage represents the cell data which should be transferred
@@ -750,13 +745,6 @@ namespace parallel
 
 
 
-    template <int dim, typename DataType>
-    ContinuousQuadratureDataTransfer<dim, DataType>::
-      ~ContinuousQuadratureDataTransfer()
-    {}
-
-
-
     template <int dim, typename DataType>
     void
     ContinuousQuadratureDataTransfer<dim, DataType>::
index 2aabb6402e9c59af8d40dd709a9e9428b2df0848..b299ed09a7563544f65a6ae03e02be3ad6cd480a 100644 (file)
@@ -439,7 +439,7 @@ public:
    * @note This function can also be used in CUDA device code.
    */
   DEAL_II_CUDA_HOST_DEV
-  Tensor();
+  Tensor() = default;
 
   /**
    * Constructor, where the data is copied from a C-style array.
@@ -1010,15 +1010,6 @@ Tensor<0, dim, Number>::serialize(Archive &ar, const unsigned int)
 /*-------------------- Inline functions: Tensor<rank,dim> --------------------*/
 
 
-template <int rank_, int dim, typename Number>
-inline DEAL_II_ALWAYS_INLINE DEAL_II_CUDA_HOST_DEV
-                             Tensor<rank_, dim, Number>::Tensor()
-{
-  // All members of the c-style array values are already default initialized
-  // and thus all values are already set to zero recursively.
-}
-
-
 template <int rank_, int dim, typename Number>
 inline DEAL_II_ALWAYS_INLINE
 Tensor<rank_, dim, Number>::Tensor(const array_type &initializer)
index b73071eaa2a4ed1361dd497e97710a7e256ed624..1db9ec293aefaf28e0c7d4a2dfe0eecfe332097c 100644 (file)
@@ -1674,7 +1674,7 @@ public:
      * automatically generated destructor would have a different one due to
      * member objects.
      */
-    virtual ~DistortedCellList() noexcept override;
+    virtual ~DistortedCellList() noexcept override = default;
 
     /**
      * A list of those cells among the coarse mesh cells that are deformed or
index 3f06dc941bc4a7019d3297b936cf036075822c14..90d1d7d46830433fddfa3866682ac348ec30ffe1 100644 (file)
@@ -175,7 +175,7 @@ public:
   /**
    * Virtual destructor.
    */
-  virtual ~SolverBicgstab() override;
+  virtual ~SolverBicgstab() override = default;
 
   /**
    * Solve primal problem only.
@@ -333,12 +333,6 @@ SolverBicgstab<VectorType>::SolverBicgstab(SolverControl &       cn,
 
 
 
-template <typename VectorType>
-SolverBicgstab<VectorType>::~SolverBicgstab()
-{}
-
-
-
 template <typename VectorType>
 template <typename MatrixType>
 double
index 32932ba88a7097d9537cf532e732bc851d64d101..d9242cfdcb3a406456d56051df1e39e7e54af402 100644 (file)
@@ -110,7 +110,7 @@ public:
   /**
    * Destructor
    */
-  ~SolverSelector() override;
+  virtual ~SolverSelector() override = default;
 
   /**
    * Solver procedure. Calls the @p solve function of the @p solver whose @p
@@ -256,12 +256,6 @@ SolverSelector<VectorType>::SolverSelector(const std::string &name,
 
 
 
-template <typename VectorType>
-SolverSelector<VectorType>::~SolverSelector()
-{}
-
-
-
 template <typename VectorType>
 void
 SolverSelector<VectorType>::select(const std::string &name)
index 7315fd9908407a56b3de3192625b7d688b6b74d6..e0143f51f754a6ec69605edaf4873bca51f1ff46 100644 (file)
@@ -2689,11 +2689,6 @@ public:
                    const unsigned int             quad_no          = 0,
                    const unsigned int             first_selected_component = 0);
 
-  /**
-   * Destructor.
-   */
-  ~FEFaceEvaluation();
-
   /**
    * Initializes the operation pointer to the current face. This method is the
    * default choice for face integration as the data stored in MappingInfo is
@@ -7148,17 +7143,6 @@ inline FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number>::
 
 
 
-template <int dim,
-          int fe_degree,
-          int n_q_points_1d,
-          int n_components_,
-          typename Number>
-inline FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number>::
-  ~FEFaceEvaluation()
-{}
-
-
-
 template <int dim,
           int fe_degree,
           int n_q_points_1d,
index f7fda0ce3d43ad54f147fd6a9390605c77d1dcaa..c04642f3bb3668a9a33bfc9806a9a6276da03c93 100644 (file)
@@ -295,11 +295,6 @@ namespace internal
     template <int dim, typename Number>
     struct MappingInfo
     {
-      /**
-       * Empty constructor.
-       */
-      MappingInfo();
-
       /**
        * Compute the information in the given cells and faces. The cells are
        * specified by the level and the index within the level (as given by
index 8da87d9807c977d7502cfbba7793756eb4e7e7e1..a342afa7fd694e18ff92d04b1fec382f2a27089a 100644 (file)
@@ -192,12 +192,6 @@ namespace internal
 
     /* ------------------------ MappingInfo implementation ----------------- */
 
-    template <int dim, typename Number>
-    MappingInfo<dim, Number>::MappingInfo()
-    {}
-
-
-
     template <int dim, typename Number>
     void
     MappingInfo<dim, Number>::clear()
index 7bbc939cf6a02b29edc9cf4378cbb59c4edd04f7..d7d973a22bebf9f2902a726e11c117c249a48155 100644 (file)
@@ -44,8 +44,7 @@ namespace internal
   struct MFWorkerInterface
   {
   public:
-    virtual ~MFWorkerInterface()
-    {}
+    virtual ~MFWorkerInterface() = default;
 
     /// Starts the communication for the update ghost values operation
     virtual void
index ade19553b58323fc70436af345eb2aec41d0324e..32b2ca23d50f727e3ff6f331645b5dbac8de35f1 100644 (file)
@@ -85,7 +85,7 @@ namespace Particles
     /**
      * Destructor.
      */
-    ~ParticleHandler() override;
+    virtual ~ParticleHandler() override = default;
 
     /**
      * Initialize the particle handler. This function does not clear the
index 305a5b3782be9c3c6f124917de6db16dfba91446..bbe0f9a53eb870c92ee91954c65b64a6bacf1f77 100644 (file)
@@ -15027,17 +15027,6 @@ Triangulation<dim, spacedim>::memory_consumption() const
 }
 
 
-
-template <int dim, int spacedim>
-Triangulation<dim, spacedim>::DistortedCellList::~DistortedCellList() noexcept
-{
-  // don't do anything here. the compiler will automatically convert
-  // any exceptions created by the destructors of the member variables
-  // into abort() in order to satisfy the throw()/noexcept
-  // specification
-}
-
-
 // explicit instantiations
 #include "tria.inst"
 
index 3d07cbb5f760a8ba01d66a2238ace872be65ff3d..17b9fb8bf8e66025e0ebed4b8273d7484ad652b7 100644 (file)
@@ -66,12 +66,6 @@ namespace Particles
 
 
 
-  template <int dim, int spacedim>
-  ParticleHandler<dim, spacedim>::~ParticleHandler()
-  {}
-
-
-
   template <int dim, int spacedim>
   void
   ParticleHandler<dim, spacedim>::initialize(

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.