]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Move default definitions to declarations
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Thu, 14 Sep 2017 21:58:05 +0000 (23:58 +0200)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Fri, 15 Sep 2017 00:20:39 +0000 (02:20 +0200)
114 files changed:
include/deal.II/algorithms/operator.h
include/deal.II/algorithms/operator.templates.h
include/deal.II/base/auto_derivative_function.h
include/deal.II/base/convergence_table.h
include/deal.II/base/data_out_base.h
include/deal.II/base/flow_function.h
include/deal.II/base/function.h
include/deal.II/base/function.templates.h
include/deal.II/base/function_time.h
include/deal.II/base/function_time.templates.h
include/deal.II/base/parameter_handler.h
include/deal.II/base/patterns.h
include/deal.II/base/table_handler.h
include/deal.II/base/tensor_function.h
include/deal.II/base/tensor_function.templates.h
include/deal.II/base/thread_local_storage.h
include/deal.II/distributed/shared_tria.h
include/deal.II/distributed/solution_transfer.h
include/deal.II/fe/fe.h
include/deal.II/fe/fe_p1nc.h
include/deal.II/fe/fe_tools.h
include/deal.II/fe/fe_tools.templates.h
include/deal.II/fe/mapping.h
include/deal.II/fe/mapping_manifold.h
include/deal.II/grid/manifold.h
include/deal.II/grid/persistent_tria.h
include/deal.II/grid/tria_boundary.h
include/deal.II/hp/fe_collection.h
include/deal.II/hp/mapping_collection.h
include/deal.II/lac/block_sparsity_pattern.h
include/deal.II/lac/block_vector.h
include/deal.II/lac/block_vector.templates.h
include/deal.II/lac/chunk_sparsity_pattern.h
include/deal.II/lac/householder.h
include/deal.II/lac/matrix_out.h
include/deal.II/lac/petsc_parallel_block_sparse_matrix.h
include/deal.II/lac/petsc_precondition.h
include/deal.II/lac/petsc_solver.h
include/deal.II/lac/precondition_block.templates.h
include/deal.II/lac/precondition_block_base.h
include/deal.II/lac/solver_control.h
include/deal.II/lac/solver_richardson.h
include/deal.II/lac/sparse_ilu.h
include/deal.II/lac/sparse_ilu.templates.h
include/deal.II/lac/sparse_matrix_ez.h
include/deal.II/lac/sparse_matrix_ez.templates.h
include/deal.II/lac/tensor_product_matrix.h
include/deal.II/lac/trilinos_block_sparse_matrix.h
include/deal.II/lac/trilinos_parallel_block_vector.h
include/deal.II/lac/trilinos_precondition.h
include/deal.II/lac/trilinos_solver.h
include/deal.II/lac/trilinos_sparse_matrix.h
include/deal.II/lac/trilinos_sparsity_pattern.h
include/deal.II/lac/trilinos_vector.h
include/deal.II/matrix_free/dof_info.h
include/deal.II/matrix_free/dof_info.templates.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/matrix_free/matrix_free.templates.h
include/deal.II/meshworker/local_integrator.h
include/deal.II/meshworker/vector_selector.h
include/deal.II/meshworker/vector_selector.templates.h
include/deal.II/multigrid/mg_base.h
include/deal.II/multigrid/mg_transfer.h
include/deal.II/multigrid/mg_transfer_block.h
include/deal.II/multigrid/mg_transfer_component.h
include/deal.II/multigrid/mg_transfer_matrix_free.h
include/deal.II/numerics/data_out_dof_data.h
include/deal.II/numerics/data_out_dof_data.templates.h
include/deal.II/numerics/data_out_stack.h
include/deal.II/numerics/data_postprocessor.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/lac/trilinos_vector.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/time_dependent.cc

index b2279bb6f2ebcf8b8a7361c24c60805f0dba9751..93d0d2aac2add44be922c3e786874d1b02e8662f 100644 (file)
@@ -73,7 +73,7 @@ namespace Algorithms
     /**
      * The virtual destructor.
      */
-    ~OperatorBase();
+    virtual ~OperatorBase() = default;
 
     /**
      * The actual operation, which is implemented in a derived class.
@@ -106,13 +106,22 @@ namespace Algorithms
   template <typename VectorType>
   class OutputOperator : public Subscriptor
   {
-    OutputOperator(const OutputOperator<VectorType> &) = delete;
   public:
+    /**
+     * Constructor initializing member variables with invalid data.
+     */
     OutputOperator ();
+
+    /**
+     * The copy constructor is deleted since objects of this class
+     * should not be copied.
+     */
+    OutputOperator(const OutputOperator<VectorType> &) = delete;
+
     /**
      * Empty virtual destructor.
      */
-    virtual ~OutputOperator();
+    virtual ~OutputOperator() = default;
 
     /**
      * Set the stream @p os to which data is written. If no stream is selected
index 328d455e5830e710d497daa851557aae650fde72..3aac1185f87979e571a5a9e68bee9ec17d131c00 100644 (file)
@@ -25,9 +25,6 @@ DEAL_II_NAMESPACE_OPEN
 
 namespace Algorithms
 {
-  template <typename VectorType>
-  OutputOperator<VectorType>::~OutputOperator() = default;
-
   template <typename VectorType>
   OutputOperator<VectorType>::OutputOperator()
     :
index 64551794a7b65265c6f2e8b1ce1f8ca39079e8c6..fba1bf23c5aee4094c235f682bafbdf650d4b9c1 100644 (file)
@@ -132,7 +132,7 @@ public:
   /**
    * Virtual destructor; absolutely necessary in this case.
    */
-  virtual ~AutoDerivativeFunction ();
+  virtual ~AutoDerivativeFunction () = default;
 
   /**
    * Choose the difference formula. See the enum #DifferenceFormula for
index 09b11adf889b3771154ee90cfd431e76d1fe35b1..58b396adb4b2187d06258de1608c8537df58eee9 100644 (file)
@@ -65,7 +65,7 @@ public:
   /**
    * Constructor.
    */
-  ConvergenceTable();
+  ConvergenceTable() = default;
 
   /**
    * Rate in relation to the rows.
index be9c8e584e1cf5a74412570fe287199d0a754c87..baf0570577f9eaf0f3da8a5947aa33b076a0dfa8 100644 (file)
@@ -2374,7 +2374,7 @@ public:
    * Destructor. Does nothing, but is declared virtual since this class has
    * virtual functions.
    */
-  virtual ~DataOutInterface ();
+  virtual ~DataOutInterface () = default;
 
   /**
    * Obtain data through get_patches() and write it to <tt>out</tt> in OpenDX
index c16fcbd630704bc6314fa919bc418087bcede1f5..0b9c8f53d23d4cf220e95336c8ff1ad3f9676ff7 100644 (file)
@@ -56,7 +56,7 @@ namespace Functions
     /**
      * Virtual destructor.
      */
-    virtual ~FlowFunction();
+    virtual ~FlowFunction() = default;
 
     /**
      * Store an adjustment for the pressure function, such that its mean value
@@ -145,7 +145,8 @@ namespace Functions
      */
     PoisseuilleFlow<dim> (const double r,
                           const double Re);
-    virtual ~PoisseuilleFlow();
+
+    virtual ~PoisseuilleFlow() = default;
 
     virtual void vector_values (const std::vector<Point<dim> > &points,
                                 std::vector<std::vector<double> > &values) const;
@@ -187,7 +188,8 @@ namespace Functions
      * Change the viscosity and the reaction parameter.
      */
     void set_parameters (const double viscosity, const double reaction);
-    virtual ~StokesCosine();
+
+    virtual ~StokesCosine() = default;
 
     virtual void vector_values (const std::vector<Point<dim> > &points,
                                 std::vector<std::vector<double> > &values) const;
@@ -276,7 +278,8 @@ namespace Functions
      * Stokes problem.
      */
     Kovasznay (const double Re, bool Stokes = false);
-    virtual ~Kovasznay();
+
+    virtual ~Kovasznay() = default;
 
     virtual void vector_values (const std::vector<Point<2> > &points,
                                 std::vector<std::vector<double> > &values) const;
index 0d4db6aaecac1505064c620702224d30f799d5e1..e440f82fdb57833f4a565c2d47189ba724373c38 100644 (file)
@@ -807,7 +807,7 @@ public:
    * This destructor is defined as virtual so as to coincide with all other
    * aspects of class.
    */
-  virtual ~VectorFunctionFromTensorFunction();
+  virtual ~VectorFunctionFromTensorFunction() = default;
 
   /**
    * Return a single component of a vector-valued function at a given point.
index e27051877e6a23271ea47f923a9f4a98d45a2688..3621675179ac41f16586787ba81142071bae3448 100644 (file)
@@ -45,6 +45,9 @@ Function<dim, Number>::Function (const unsigned int n_components,
 }
 
 
+
+// The destructor is pure virtual so we can't default it
+// in the declaration.
 template <int dim, typename Number>
 Function<dim, Number>::~Function () = default;
 
@@ -679,9 +682,6 @@ VectorFunctionFromTensorFunction<dim, Number>::VectorFunctionFromTensorFunction
 }
 
 
-template <int dim, typename Number>
-VectorFunctionFromTensorFunction<dim, Number>::~VectorFunctionFromTensorFunction () = default;
-
 
 template <int dim, typename Number>
 inline
index 3753e728eccef53fa7030980b05f1fedea51abe2..5c4589c8f176a4b1534fe70da271cbaedd41752a 100644 (file)
@@ -81,7 +81,7 @@ public:
   /**
    * Virtual destructor.
    */
-  virtual ~FunctionTime();
+  virtual ~FunctionTime() = default;
 
   /**
    * Return the value of the time variable.
index 85955b06533ea16011a6c194aabf664a7611b8a6..b0e849bad288ef3eb955ae26ea904573be38a191 100644 (file)
@@ -29,11 +29,6 @@ FunctionTime<Number>::FunctionTime(const Number initial_time)
 
 
 
-template <typename Number>
-FunctionTime<Number>::~FunctionTime() = default;
-
-
-
 template <typename Number>
 void
 FunctionTime<Number>::set_time (const Number new_time)
index 35fb351083fab5b9c9fe89be0284bf76265b62bf..e89dd053d6880a950ea776ec515745f704271271 100644 (file)
@@ -863,7 +863,7 @@ public:
    * safer as we have virtual functions.  It actually does nothing
    * spectacular.
    */
-  virtual ~ParameterHandler ();
+  virtual ~ParameterHandler () = default;
 
   /**
    * Parse each line from a stream until the stream returns the <tt>eof</tt>
@@ -1765,7 +1765,7 @@ public:
      * Destructor. It doesn't actually do anything, but is declared to force
      * derived classes to have a virtual destructor.
      */
-    virtual ~UserClass ();
+    virtual ~UserClass () = default;
 
     /**
      * <tt>create_new</tt> must provide a clean object, either by creating a
@@ -1788,7 +1788,7 @@ public:
    * Destructor. Declare this only to have a virtual destructor, which is
    * safer as we have virtual functions. It actually does nothing spectacular.
    */
-  virtual ~MultipleParameterLoop ();
+  virtual ~MultipleParameterLoop () = default;
 
   /**
    * Read input from a stream until the stream returns the <tt>eof</tt>
index 9840586877bf028e29594e1b684053c1eaaa29f2..cfeda361e6dcc9049374ac9fe09abf95ef725220 100644 (file)
@@ -74,7 +74,7 @@ namespace Patterns
     /**
      * Make destructor of this and all derived classes virtual.
      */
-    virtual ~PatternBase ();
+    virtual ~PatternBase () = default;
 
     /**
      * Return <tt>true</tt> if the given string matches the pattern.
@@ -787,7 +787,7 @@ namespace Patterns
      * Constructor. (Allow for at least one non-virtual function in this
      * class, as otherwise sometimes no virtual table is emitted.)
      */
-    Anything ();
+    Anything () = default;
 
     /**
      * Return <tt>true</tt> if the string matches its constraints, i.e.
@@ -919,7 +919,7 @@ namespace Patterns
     /**
      * Constructor.
      */
-    DirectoryName ();
+    DirectoryName () = default;
 
     /**
      * Return <tt>true</tt> if the string matches its constraints, i.e.
index cdc38542bbb5d52f54c02ffd928b7d6481a8ce0f..025f675ea93ce98ad58a8c3f32978ef858159a82 100644 (file)
@@ -54,7 +54,7 @@ namespace internal
     /**
      * Default constructor.
      */
-    TableEntry ();
+    TableEntry () = default;
 
     /**
      * Constructor. Initialize this table element with the value
index 3e34f5c0076df0696ad8bb11582870fcb1fa48a2..c67c7160b7d18f04bf52978124cbe303b433d18f 100644 (file)
@@ -75,7 +75,7 @@ public:
    * usually not used by their true type, but rather through pointers to this
    * base class.
    */
-  virtual ~TensorFunction ();
+  virtual ~TensorFunction () = default;
 
   /**
    * Return the value of the function at the given point.
@@ -127,7 +127,7 @@ public:
   ConstantTensorFunction (const dealii::Tensor<rank, dim, Number> &value,
                           const Number initial_time = 0.0);
 
-  virtual ~ConstantTensorFunction ();
+  virtual ~ConstantTensorFunction () = default;
 
   virtual typename dealii::TensorFunction<rank, dim, Number>::value_type value (const Point<dim> &p) const;
 
index 6e98ee34dfe7c3e8f8557e89e26115468fbaeec2..157e3c415216855468b40f3bbef29d76e75e322e 100644 (file)
@@ -33,9 +33,6 @@ TensorFunction<rank, dim, Number>::TensorFunction (const Number initial_time)
 {}
 
 
-template <int rank, int dim, typename Number>
-TensorFunction<rank, dim, Number>::~TensorFunction () = default;
-
 
 template <int rank, int dim, typename Number>
 typename TensorFunction<rank, dim, Number>::value_type
@@ -94,9 +91,6 @@ ConstantTensorFunction<rank, dim, Number>::ConstantTensorFunction (
 {}
 
 
-template <int rank, int dim, typename Number>
-ConstantTensorFunction<rank, dim, Number>::~ConstantTensorFunction () = default;
-
 
 template <int rank, int dim, typename Number>
 typename TensorFunction<rank, dim, Number>::value_type
index 5553034da4dc06b13c81538e2b066af228b27bbe..dbb20cd9db5cf7dea7bdfe7a9d265228a647081d 100644 (file)
@@ -74,7 +74,7 @@ namespace Threads
      * Default constructor. Initialize each thread local object using its
      * default constructor.
      */
-    ThreadLocalStorage ();
+    ThreadLocalStorage () = default;
 
     /**
      * A kind of copy constructor. Initialize each thread local object by
@@ -179,11 +179,6 @@ namespace Threads
 
 // ----------------- inline and template functions ----------------------------
 
-  template <typename T>
-  inline
-  ThreadLocalStorage<T>::ThreadLocalStorage() = default;
-
-
   template <typename T>
   inline
   ThreadLocalStorage<T>::ThreadLocalStorage(const T &t)
index 4a2840ab899171d91513e0ddfbaf9b2277b5dcdc..20d865ea79a2074447671f3335042cf61f036f3a 100644 (file)
@@ -207,7 +207,7 @@ namespace parallel
       /**
        * Destructor.
        */
-      virtual ~Triangulation ();
+      virtual ~Triangulation () = default;
 
       /**
        * Coarsen and refine the mesh according to refinement and coarsening
index 37e047ac72836ec5e96ed9b5d26a944263040634..21763a78bed4b289d0687e096ba4c8ba8076288f 100644 (file)
@@ -131,7 +131,7 @@ namespace parallel
       /**
        * Destructor.
        */
-      ~SolutionTransfer();
+      ~SolutionTransfer() = default;
 
       /**
        * Prepares the @p SolutionTransfer for coarsening and refinement. It
index f59bba7aa98021d316cf707e3c724c1481caea3b..62f0ae008517111b3148bef2a056eb14adc7697a 100644 (file)
@@ -683,7 +683,7 @@ public:
     /**
      * Destructor. Made virtual to allow polymorphism.
      */
-    virtual ~InternalDataBase ();
+    virtual ~InternalDataBase () = default;
 
     /**
      * A set of update flags specifying the kind of information that an
index c2ec8e7bc4bc22e3965f8d86ea60639fd76fb037..555201c82e62fca1f47a6fe47c618b50afef5b59 100644 (file)
@@ -272,7 +272,7 @@ public:
   /**
    * Destructor.
    */
-  virtual ~FE_P1NC ();
+  virtual ~FE_P1NC () = default;
 
 
 
index e755dfee0251b538917902d4c7c915c2c1cec3d7..202fec1088bab360f5da760fdee80eebe3e0a177 100644 (file)
@@ -96,7 +96,7 @@ namespace FETools
     /**
      * Virtual destructor doing nothing but making the compiler happy.
      */
-    virtual ~FEFactoryBase();
+    virtual ~FEFactoryBase() = default;
   };
 
   /**
index e247033ddbbf565bdef76cfa48029c5775252f52..b10f0efd72cc78fdefe854fad9e6e1b88cec236e 100644 (file)
@@ -1318,11 +1318,6 @@ namespace
 
 namespace FETools
 {
-  template <int dim, int spacedim>
-  FEFactoryBase<dim,spacedim>::~FEFactoryBase() = default;
-
-
-
   template <int dim, int spacedim>
   void compute_component_wise(
     const FiniteElement<dim,spacedim> &element,
index 3ea53c36e547ade9a36a93e3b4e22aee458026de..c23c772dfc178a54a82daace02c8afc7f1388611 100644 (file)
@@ -291,7 +291,7 @@ public:
   /**
    * Virtual destructor.
    */
-  virtual ~Mapping ();
+  virtual ~Mapping () = default;
 
   /**
    * Return a pointer to a copy of the present object. The caller of this copy
@@ -525,12 +525,6 @@ public:
    */
   class InternalDataBase
   {
-  private:
-    /**
-     * Copy construction is forbidden.
-     */
-    InternalDataBase (const InternalDataBase &) = delete;
-
   public:
     /**
      * Constructor. Sets update_flags to @p update_default and @p first_cell
@@ -538,10 +532,15 @@ public:
      */
     InternalDataBase ();
 
+    /**
+     * Copy construction is forbidden.
+     */
+    InternalDataBase (const InternalDataBase &) = delete;
+
     /**
      * Virtual destructor for derived classes
      */
-    virtual ~InternalDataBase ();
+    virtual ~InternalDataBase () = default;
 
     /**
      * A set of update flags specifying the kind of information that an
index f30bb268bbfba3ad92e92c858b6ecfb5cbaa9c38..c86a5b22dd28d6afc060849ced69aca9c6dfe1ed 100644 (file)
@@ -63,7 +63,7 @@ public:
   /**
    * Constructor.
    */
-  MappingManifold ();
+  MappingManifold () = default;
 
   /**
    * Copy constructor.
@@ -174,7 +174,7 @@ public:
     /**
      * Constructor.
      */
-    InternalData();
+    InternalData() = default;
 
     /**
      * Initialize the object's member variables related to cell data based on
index 64e12e0f434b0d03822ddb5f1d498a5fe89ccb91..f4bb2ac072f62653044f05a694cd2b38901c352f 100644 (file)
@@ -345,7 +345,7 @@ public:
    * Destructor. Does nothing here, but needs to be declared virtual to make
    * class hierarchies derived from this class possible.
    */
-  virtual ~Manifold ();
+  virtual ~Manifold () = default;
 
   /**
    * @name Computing the location of points.
@@ -930,7 +930,7 @@ public:
    * Destructor. Does nothing here, but needs to be declared to make it
    * virtual.
    */
-  virtual ~ChartManifold ();
+  virtual ~ChartManifold () = default;
 
   /**
    * Refer to the general documentation of this class and the documentation of
index aa4446b0cb6fdbb71c5faaa6a386b45f4f4b40e8..b61281fc671a8b41bd0a68eb0cdd64c730dacc97 100644 (file)
@@ -133,7 +133,7 @@ public:
   /**
    * Destructor.
    */
-  virtual ~PersistentTriangulation ();
+  virtual ~PersistentTriangulation () = default;
 
   /**
    * Overloaded version of the same function in the base class which stores
index f3195cf55686b4f11676f567f4494b66cad8c22d..84d20d893c615724e436a1fff8ecfa01503e2d78 100644 (file)
@@ -86,7 +86,7 @@ public:
    * Destructor. Does nothing here, but needs to be declared to make it
    * virtual.
    */
-  virtual ~Boundary ();
+  virtual ~Boundary () = default;
 
 
   /**
@@ -241,7 +241,7 @@ public:
   /**
    * Default constructor. Some compilers require this for some reasons.
    */
-  StraightBoundary ();
+  StraightBoundary () = default;
 
   /**
    * Let the new point be the arithmetic mean of the two vertices of the line.
index 044d6cd71f0c155811600f25c3ce4f4c9c0036ae..e37e14afc7610f6c63d384e716409c9694c3e58c 100644 (file)
@@ -58,7 +58,7 @@ namespace hp
      * Default constructor. Leads to an empty collection that can later be
      * filled using push_back().
      */
-    FECollection ();
+    FECollection () = default;
 
     /**
      * Conversion constructor. This constructor creates a FECollection from a
index d6e0bbb821814c5acf3824f930fdec5c732040ae..b43bb00d75d41a7fd262acf4be69900e1a98355b 100644 (file)
@@ -58,7 +58,7 @@ namespace hp
      * Default constructor. Leads to an empty collection that can later be
      * filled using push_back().
      */
-    MappingCollection ();
+    MappingCollection () = default;
 
     /**
      * Conversion constructor. This constructor creates a MappingCollection
index 34e7cbba6e831d429c332e871fde3203178801dc..43b33615f3bf6ce369c6574a271bfc61421e0753 100644 (file)
@@ -382,7 +382,7 @@ public:
    * useful if you want such objects as member variables in other classes. You
    * can make the structure usable by calling the reinit() function.
    */
-  BlockSparsityPattern ();
+  BlockSparsityPattern () = default;
 
   /**
    * Initialize the matrix with the given number of block rows and columns.
@@ -488,7 +488,7 @@ public:
    * useful if you want such objects as member variables in other classes. You
    * can make the structure usable by calling the reinit() function.
    */
-  BlockDynamicSparsityPattern ();
+  BlockDynamicSparsityPattern () = default;
 
   /**
    * Initialize the matrix with the given number of block rows and columns.
@@ -604,7 +604,7 @@ namespace TrilinosWrappers
      * useful if you want such objects as member variables in other classes.
      * You can make the structure usable by calling the reinit() function.
      */
-    BlockSparsityPattern ();
+    BlockSparsityPattern () = default;
 
     /**
      * Initialize the matrix with the given number of block rows and columns.
index 13fd7d02a6d16677f7f77bd39231ff3e1f752595..64a7f3f32cb3ac312f095006434347c46c82903d 100644 (file)
@@ -167,7 +167,7 @@ public:
   /**
    * Destructor. Clears memory
    */
-  ~BlockVector ();
+  ~BlockVector () = default;
 
   /**
    * Call the compress() function on all the subblocks.
index 3d7d25e6b327957dfa1860b3c77dc1b95294e013..73dc5db2f8b9cf81308ba3ed399bfa85184aeb4c 100644 (file)
@@ -141,11 +141,6 @@ void BlockVector<Number>::reinit (const BlockVector<Number2> &v,
 
 
 
-template <typename Number>
-BlockVector<Number>::~BlockVector () = default;
-
-
-
 #ifdef DEAL_II_WITH_TRILINOS
 template <typename Number>
 inline
index 48aa237c8737aab818204d5d5f5f640d668507bb..31392ac36e6c982660a4bf14bf96750a4a5119cf 100644 (file)
@@ -334,7 +334,7 @@ public:
   /**
    * Destructor.
    */
-  ~ChunkSparsityPattern ();
+  ~ChunkSparsityPattern () = default;
 
   /**
    * Copy operator. For this the same holds as for the copy constructor: it is
index 960dc9ddc6a0794246407803bdf167a39d2fd0ee..484ba02a87297d6802914005777830a339e8fc4e 100644 (file)
@@ -64,7 +64,7 @@ public:
   /**
    * Create an empty object.
    */
-  Householder ();
+  Householder () = default;
 
   /**
    * Create an object holding the QR-decomposition of a matrix.
@@ -125,11 +125,6 @@ private:
 
 // QR-transformation cf. Stoer 1 4.8.2 (p. 191)
 
-template <typename number>
-Householder<number>::Householder() = default;
-
-
-
 template <typename number>
 template <typename number2>
 void
index cf401940c34b7e642bf053a1b2d49d8aea71271e..ddb5ad279dc1e3c4e774a7de4507e88f30a0edc5 100644 (file)
@@ -114,7 +114,7 @@ public:
   /**
    * Destructor. Declared in order to make it virtual.
    */
-  virtual ~MatrixOut ();
+  virtual ~MatrixOut () = default;
 
   /**
    * Generate a list of patches from the given matrix and use the given string
index 57f218efa12d7d952e167c50a316538e87d5fe2d..eb5e27701407459d07257d38812541276f1310d9 100644 (file)
@@ -101,12 +101,12 @@ namespace PETScWrappers
        * reinit(BlockSparsityPattern). The number of blocks per row and column
        * are then determined by that function.
        */
-      BlockSparseMatrix ();
+      BlockSparseMatrix () = default;
 
       /**
        * Destructor.
        */
-      ~BlockSparseMatrix ();
+      ~BlockSparseMatrix () = default;
 
       /**
        * Pseudo copy operator only copying empty objects. The sizes of the
index e050bbac6fa80328674922b859e947ae31023313..bf93ab3dfedcba8562b79dc71c652e75f2dbef99 100644 (file)
@@ -141,7 +141,7 @@ namespace PETScWrappers
      * Empty Constructor. You need to call initialize() before using this
      * object.
      */
-    PreconditionJacobi ();
+    PreconditionJacobi () = default;
 
 
     /**
@@ -215,7 +215,7 @@ namespace PETScWrappers
      * Empty Constructor. You need to call initialize() before using this
      * object.
      */
-    PreconditionBlockJacobi ();
+    PreconditionBlockJacobi () = default;
 
     /**
      * Constructor. Take the matrix which is used to form the preconditioner,
@@ -291,7 +291,7 @@ namespace PETScWrappers
      * Empty Constructor. You need to call initialize() before using this
      * object.
      */
-    PreconditionSOR ();
+    PreconditionSOR () = default;
 
     /**
      * Constructor. Take the matrix which is used to form the preconditioner,
@@ -351,7 +351,7 @@ namespace PETScWrappers
      * Empty Constructor. You need to call initialize() before using this
      * object.
      */
-    PreconditionSSOR ();
+    PreconditionSSOR () = default;
 
     /**
      * Constructor. Take the matrix which is used to form the preconditioner,
@@ -414,7 +414,7 @@ namespace PETScWrappers
      * Empty Constructor. You need to call initialize() before using this
      * object.
      */
-    PreconditionEisenstat ();
+    PreconditionEisenstat () = default;
 
     /**
      * Constructor. Take the matrix which is used to form the preconditioner,
@@ -474,7 +474,7 @@ namespace PETScWrappers
      * Empty Constructor. You need to call initialize() before using this
      * object.
      */
-    PreconditionICC ();
+    PreconditionICC () = default;
 
     /**
      * Constructor. Take the matrix which is used to form the preconditioner,
@@ -534,7 +534,7 @@ namespace PETScWrappers
      * Empty Constructor. You need to call initialize() before using this
      * object.
      */
-    PreconditionILU ();
+    PreconditionILU () = default;
 
     /**
      * Constructor. Take the matrix which is used to form the preconditioner,
@@ -612,7 +612,7 @@ namespace PETScWrappers
      * Empty Constructor. You need to call initialize() before using this
      * object.
      */
-    PreconditionLU ();
+    PreconditionLU () = default;
 
     /**
      * Constructor. Take the matrix which is used to form the preconditioner,
@@ -718,7 +718,7 @@ namespace PETScWrappers
      * Empty Constructor. You need to call initialize() before using this
      * object.
      */
-    PreconditionBoomerAMG ();
+    PreconditionBoomerAMG () = default;
 
     /**
      * Constructor. Take the matrix which is used to form the preconditioner,
@@ -859,7 +859,7 @@ namespace PETScWrappers
      * Empty Constructor. You need to call initialize() before using this
      * object.
      */
-    PreconditionParaSails ();
+    PreconditionParaSails () = default;
 
     /**
      * Constructor. Take the matrix which is used to form the preconditioner,
@@ -906,7 +906,7 @@ namespace PETScWrappers
      * Empty Constructor. You need to call initialize() before using this
      * object.
      */
-    PreconditionNone ();
+    PreconditionNone () = default;
 
     /**
      * Constructor. Take the matrix which is used to form the preconditioner,
index 73ba09e5648903bae807a83c8ed386dec0af874c..33e9db2f61753241fd1dc1b07c8ef6ac31da85dd 100644 (file)
@@ -122,7 +122,7 @@ namespace PETScWrappers
     /**
      * Destructor.
      */
-    virtual ~SolverBase ();
+    virtual ~SolverBase () = default;
 
     /**
      * Solve the linear system <tt>Ax=b</tt>. Depending on the information
index eb81a04d05a16f21e8c70795fdf75c73d65cfd25..d2c8f8c897e69df3c8bbbc9b4ff819d9dfc4ad57 100644 (file)
@@ -45,9 +45,6 @@ AdditionalData (const size_type block_size,
 {}
 
 
-template <typename number>
-PreconditionBlockBase<number>::~PreconditionBlockBase () = default;
-
 
 template <typename MatrixType, typename inverse_type>
 PreconditionBlock<MatrixType,inverse_type>::PreconditionBlock (bool store)
index dd4479303316c202b49c89ac38d7a6595541cf7c..9953ddf5282ba4325d6ced6ab04856c9b08845ae 100644 (file)
@@ -89,7 +89,7 @@ public:
   /**
    * The virtual destructor
    */
-  ~PreconditionBlockBase();
+  ~PreconditionBlockBase() = default;
 
   /**
    * Deletes the inverse diagonal block matrices if existent hence leaves the
index c8e46135227eb96ceb9ddc0b396af1853cc424c4..e6c57a8c7a7ff1e12317c2779b9e91d4bdc7e304 100644 (file)
@@ -155,7 +155,7 @@ public:
    * Virtual destructor is needed as there are virtual functions in this
    * class.
    */
-  virtual ~SolverControl();
+  virtual ~SolverControl() = default;
 
   /**
    * Interface to parameter file.
@@ -429,7 +429,7 @@ public:
    * Virtual destructor is needed as there are virtual functions in this
    * class.
    */
-  virtual ~ReductionControl();
+  virtual ~ReductionControl() = default;
 
   /**
    * Interface to parameter file.
@@ -513,7 +513,7 @@ public:
    * Virtual destructor is needed as there are virtual functions in this
    * class.
    */
-  virtual ~IterationNumberControl();
+  virtual ~IterationNumberControl() = default;
 
   /**
    * Decide about success or failure of an iteration. This function bases
@@ -569,7 +569,7 @@ public:
    * Virtual destructor is needed as there are virtual functions in this
    * class.
    */
-  virtual ~ConsecutiveControl();
+  virtual ~ConsecutiveControl() = default;
 
   /**
    * Decide about success or failure of an iteration, see the class description
index 91e02102c1064905ce4d1ecfa7b3d7c6668793ad..487f8e55907b2838d1722b2e9b68bb194bdf29fa 100644 (file)
@@ -102,7 +102,7 @@ public:
   /**
    * Virtual destructor.
    */
-  virtual ~SolverRichardson ();
+  virtual ~SolverRichardson () = default;
 
   /**
    * Solve the linear system $Ax=b$ for x.
@@ -192,10 +192,6 @@ SolverRichardson<VectorType>::SolverRichardson(SolverControl        &cn,
 
 
 
-template <class VectorType>
-SolverRichardson<VectorType>::~SolverRichardson() = default;
-
-
 template <class VectorType>
 template <typename MatrixType, typename PreconditionerType>
 void
index a03374ee66d26fb2ec18980303a26f88143c9b50..ebff352e2fc5fa672e639deb647454b1d9397824 100644 (file)
@@ -71,7 +71,7 @@ public:
    * Call the @p initialize function before using this object as
    * preconditioner.
    */
-  SparseILU ();
+  SparseILU () = default;
 
   /**
    * Make SparseLUDecomposition::AdditionalData accessible to this class as
index 909950e8576f48013d502553809e4bed334d7273..b685b8860c5ccc21847d41ee277f102f8d9c99fb 100644 (file)
 
 DEAL_II_NAMESPACE_OPEN
 
-template <typename number>
-SparseILU<number>::SparseILU () = default;
-
-
 
 template <typename number>
 template <typename somenumber>
index c79654870693d8855c8615f2148b3610c1a0d8ba..5f5228b77d50fb49f4d2b709b2b4c013e60d87af 100644 (file)
@@ -327,7 +327,7 @@ public:
    * Destructor. Free all memory, but do not release the memory of the
    * sparsity structure.
    */
-  ~SparseMatrixEZ ();
+  ~SparseMatrixEZ () = default;
 
   /**
    * Pseudo operator only copying empty objects.
index 7589d8917139b3b747cea76efe7fddbbccbec120..6a6f3623bbb292cf51061a6582852e21fb02d103 100644 (file)
@@ -63,9 +63,6 @@ SparseMatrixEZ<number>::SparseMatrixEZ(const size_type    n_rows,
 }
 
 
-template <typename number>
-SparseMatrixEZ<number>::~SparseMatrixEZ() = default;
-
 
 template <typename number>
 SparseMatrixEZ<number> &
index e3a69861d529df047e614844c1b009e094a8b11b..b4804e10542bbe787d587f9e4c662187a1eea218 100644 (file)
@@ -103,7 +103,7 @@ public:
   /**
    * Constructor.
    */
-  TensorProductMatrixSymmetricSum();
+  TensorProductMatrixSymmetricSum() = default;
 
   /**
    * Constructor that is equivalent to the previous constructor and
@@ -203,13 +203,6 @@ private:
 #ifndef DOXYGEN
 
 
-template <int dim, typename Number, int size>
-inline
-TensorProductMatrixSymmetricSum<dim,Number,size>
-::TensorProductMatrixSymmetricSum() = default;
-
-
-
 template <int dim, typename Number, int size>
 inline
 TensorProductMatrixSymmetricSum<dim,Number,size>
index 3595b2571aad652d1058cbdb7ff244fd242f5216..bd0ca5062bf5d36df0d6ccf9467aea976eea6762 100644 (file)
@@ -104,7 +104,7 @@ namespace TrilinosWrappers
      * reinit(BlockSparsityPattern). The number of blocks per row and column
      * are then determined by that function.
      */
-    BlockSparseMatrix ();
+    BlockSparseMatrix () = default;
 
     /**
      * Destructor.
@@ -116,7 +116,7 @@ namespace TrilinosWrappers
      * matrices need to be the same.
      */
     BlockSparseMatrix &
-    operator = (const BlockSparseMatrix &);
+    operator = (const BlockSparseMatrix &) = default;
 
     /**
      * This operator assigns a scalar to a matrix. Since this does usually not
index 16884c0133b97dca04a27273965861f7861fbb7d..2065284fe3087bf3ac4000b11ba710163aff29c8 100644 (file)
@@ -138,7 +138,7 @@ namespace TrilinosWrappers
       /**
        * Destructor. Clears memory
        */
-      ~BlockVector ();
+      ~BlockVector () = default;
 
       /**
        * Copy operator: fill all components of the vector that are locally
index ae348b4a4604c1c02dc6260f577d448b4cbf1eb4..a12605897a9d7530698ed9cfa668e79c7aaf4ccb 100644 (file)
@@ -106,7 +106,7 @@ namespace TrilinosWrappers
     /**
      * Destructor.
      */
-    ~PreconditionBase ();
+    ~PreconditionBase () = default;
 
     /**
      * Destroys the preconditioner, leaving an object like just after having
index db88a344c70fcf14337fad1e4f11d07c4a626fe1..17e672d3429edf6229d656025917bd81be1402b5 100644 (file)
@@ -146,7 +146,7 @@ namespace TrilinosWrappers
     /**
      * Destructor.
      */
-    virtual ~SolverBase ();
+    virtual ~SolverBase () = default;
 
     /**
      * Solve the linear system <tt>Ax=b</tt>. Depending on the information
@@ -628,7 +628,7 @@ namespace TrilinosWrappers
     /**
      * Destructor.
      */
-    virtual ~SolverDirect ();
+    virtual ~SolverDirect () = default;
 
     /**
      * Initializes the direct solver for the matrix <tt>A</tt> and creates a
index 03a14892b1f0b8e046fec6bcd236675805e8faac..263d3feab2bbdc3c313b677c15f4c09486dd6a90 100644 (file)
@@ -570,7 +570,7 @@ namespace TrilinosWrappers
     /**
      * Destructor. Made virtual so that one can use pointers to this class.
      */
-    virtual ~SparseMatrix ();
+    virtual ~SparseMatrix () = default;
 
     /**
      * This function initializes the Trilinos matrix with a deal.II sparsity
@@ -2187,7 +2187,7 @@ namespace TrilinosWrappers
         /**
          * Destructor
          */
-        virtual ~TrilinosPayload();
+        virtual ~TrilinosPayload() = default;
 
         /**
          * Returns a payload configured for identity operations
index f3a26c98007116aa4543caf6447f04a06804335e..9604c532295417a65cf651e4ab530c7eddad4a50 100644 (file)
@@ -325,7 +325,7 @@ namespace TrilinosWrappers
     /**
      * Destructor. Made virtual so that one can use pointers to this class.
      */
-    virtual ~SparsityPattern ();
+    virtual ~SparsityPattern () = default;
 
     /**
      * Initialize a sparsity pattern that is completely stored locally, having
index 718a8e0a162cd065ad6fba1e7ec31ccec3bb13a8..521b2a469b8093709e8c13f5af3e6fba522cfc98 100644 (file)
@@ -507,7 +507,7 @@ namespace TrilinosWrappers
       /**
        * Destructor.
        */
-      ~Vector ();
+      ~Vector () = default;
 
       /**
        * Release all memory and return to a state just like after having called
index 4ab9b378a0f202c988814ee171663862bd462475..98ad91d4133a33643fa8c6a0ac5b9f71b1d7d88d 100644 (file)
@@ -66,7 +66,7 @@ namespace internal
       /**
        * Copy constructor.
        */
-      DoFInfo (const DoFInfo &dof_info);
+      DoFInfo (const DoFInfo &dof_info) = default;
 
       /**
        * Clear all data fields in this class.
index 06ebdc54314d91756587da875981930ccce7fb02..f51570268fc5aaea8a5f71d5b9fd6a229d024ad2 100644 (file)
@@ -131,10 +131,6 @@ namespace internal
 
 
 
-    DoFInfo::DoFInfo (const DoFInfo &dof_info_in) = default;
-
-
-
     void
     DoFInfo::clear ()
     {
index 96771c554a0dee22cefe6d309c8d7712ae787b6f..84e28635f838ac8321e2a13f4035e0341354559d 100644 (file)
@@ -295,7 +295,7 @@ public:
   /**
    * Destructor.
    */
-  ~MatrixFree();
+  ~MatrixFree() = default;
 
   /**
    * Extracts the information needed to perform loops over cells. The
index 5e3c94b5605b57ffccce8945c79b0782b0df5992..22b8eade937b24cf87b3316b7290a99fe0475594 100644 (file)
@@ -58,11 +58,6 @@ MatrixFree<dim, Number>::MatrixFree(const MatrixFree<dim,Number> &other)
 
 
 
-template <int dim, typename Number>
-MatrixFree<dim,Number>::~MatrixFree() = default;
-
-
-
 template <int dim, typename Number>
 void MatrixFree<dim,Number>::
 copy_from (const MatrixFree<dim,Number> &v)
index 78e87dc49c4ef0c81ee26de0c4de8fd619b19cf7..4d7dbabefa537dd760dfab6692730d1c871651ac 100644 (file)
@@ -66,7 +66,7 @@ namespace MeshWorker
     /**
      * The empty virtual destructor.
      */
-    ~LocalIntegrator();
+    virtual ~LocalIntegrator() = default;
 
     /**
      * Virtual function for integrating on cells. Throws exception
index 0724e3c06df87d453e9a8fefd34f7db221e67277..14078ad2e2d1afd71c2d0838bb5baa9fe8256c7d 100644 (file)
@@ -180,7 +180,7 @@ namespace MeshWorker
     /**
      * Constructor
      */
-    VectorDataBase();
+    VectorDataBase() = default;
 
     /**
      * Constructor from a base class object
@@ -199,7 +199,7 @@ namespace MeshWorker
     /**
      * Virtual, but empty destructor.
      */
-    virtual ~VectorDataBase();
+    virtual ~VectorDataBase() = default;
 
     /**
      * The only function added to VectorSelector is an abstract virtual
index 4e90925b7bc734116ddf373009dc40d370e48403..bc4cf4cfe325d3f307ee314eb13329082b530cc2 100644 (file)
@@ -25,11 +25,6 @@ DEAL_II_NAMESPACE_OPEN
 
 namespace MeshWorker
 {
-  template <int dim, int spacedim, typename Number>
-  VectorDataBase<dim, spacedim, Number>::~VectorDataBase() = default;
-
-
-
   template <int dim, int spacedim, typename Number>
   VectorDataBase<dim, spacedim, Number>::VectorDataBase(const VectorSelector &v)
     :
@@ -38,11 +33,6 @@ namespace MeshWorker
 
 
 
-  template <int dim, int spacedim, typename Number>
-  VectorDataBase<dim, spacedim, Number>::VectorDataBase() = default;
-
-
-
   template <int dim, int spacedim, typename Number>
   void
   VectorDataBase<dim, spacedim, Number>::initialize(const AnyData &d)
index 6e8dc57f618e79d9987a56bf0306d53bddcbaea3..6cee199acefb9da26877b72b819cc6109b70fce4 100644 (file)
@@ -50,7 +50,7 @@ public:
   /*
    * Virtual destructor.
    */
-  virtual ~MGMatrixBase();
+  virtual ~MGMatrixBase() = default;
 
   /**
    * Matrix-vector-multiplication on a certain level.
@@ -106,7 +106,7 @@ public:
   /**
    * Virtual destructor.
    */
-  virtual ~MGCoarseGridBase ();
+  virtual ~MGCoarseGridBase () = default;
 
   /**
    * Solution operator.
@@ -171,7 +171,7 @@ public:
   /**
    * Destructor. Does nothing here, but needs to be declared virtual anyway.
    */
-  virtual ~MGTransferBase();
+  virtual ~MGTransferBase() = default;
 
   /**
    * Prolongate a vector from level <tt>to_level-1</tt> to level
@@ -237,7 +237,7 @@ public:
   /**
    * Virtual destructor.
    */
-  virtual ~MGSmootherBase();
+  virtual ~MGSmootherBase() = default;
 
   /**
    * Release matrices.
index ba8828c9dcbf3bbdc2096d97d2d7b5e4163ecdf5..075c86c47d9d2bdf503927caf7bd701bf02190c6 100644 (file)
@@ -461,7 +461,7 @@ public:
    * Constructor without constraint matrices. Use this constructor only with
    * discontinuous finite elements or with no local refinement.
    */
-  MGTransferPrebuilt ();
+  MGTransferPrebuilt () = default;
 
   /**
    * Constructor with constraints. Equivalent to the default constructor
@@ -481,7 +481,7 @@ public:
   /**
    * Destructor.
    */
-  virtual ~MGTransferPrebuilt ();
+  virtual ~MGTransferPrebuilt () = default;
 
   /**
    * Initialize the constraints to be used in build_matrices().
index d66a8c98d9b5d38fc648b205d773e7a4ae48b977..2fc420bf349a788c630ddba018c28ee19340d6a0 100644 (file)
@@ -322,7 +322,7 @@ public:
   /**
    * Destructor.
    */
-  virtual ~MGTransferBlockSelect ();
+  virtual ~MGTransferBlockSelect () = default;
 
   /**
    * Actually build the prolongation matrices for grouped blocks.
index 9694cd112f8703501687d1f5fa089ac6e18e0f76..16506f7cca13746ab22e5dd1c0aaa2dfd7f77aff 100644 (file)
@@ -186,7 +186,7 @@ public:
   /**
    * Destructor.
    */
-  virtual ~MGTransferSelect ();
+  virtual ~MGTransferSelect () = default;
 
 //TODO: rewrite docs; make sure defaulted args are actually allowed
   /**
index 8af396967d55efeedcf4d53f092eadd3928ac35f..4cf4345b8090bf5557df9c64833f2c341413b82e 100644 (file)
@@ -68,7 +68,7 @@ public:
   /**
    * Destructor.
    */
-  virtual ~MGTransferMatrixFree ();
+  virtual ~MGTransferMatrixFree () = default;
 
   /**
    * Initialize the constraints to be used in build().
@@ -258,7 +258,7 @@ public:
    * Constructor without constraint matrices. Use this constructor only with
    * discontinuous finite elements or with no local refinement.
    */
-  MGTransferBlockMatrixFree ();
+  MGTransferBlockMatrixFree () = default;
 
   /**
    * Constructor with constraints. Equivalent to the default constructor
@@ -269,7 +269,7 @@ public:
   /**
    * Destructor.
    */
-  virtual ~MGTransferBlockMatrixFree ();
+  virtual ~MGTransferBlockMatrixFree () = default;
 
   /**
    * Initialize the constraints to be used in build().
index f4c92e326acbea28fdb2956e5425cfdbd345133c..646293443c4912aee4159d55c788efe8dfd14c12 100644 (file)
@@ -182,7 +182,7 @@ namespace internal
       /**
        * Destructor made virtual.
        */
-      virtual ~DataEntryBase ();
+      virtual ~DataEntryBase () = default;
 
       /**
        * Assuming that the stored vector is a cell vector, extract the given
index 33c36c616e5c047c0ea8d2c12b1f92e32ac5dd48..83d0c7f391a30f15bdf69dfdc919a0e4f0c74e90 100644 (file)
@@ -370,11 +370,6 @@ namespace internal
 
 
 
-    template <typename DoFHandlerType>
-    DataEntryBase<DoFHandlerType>::~DataEntryBase () = default;
-
-
-
     /**
      * Class that stores a pointer to a vector of type equal to the template
      * argument, and provides the functions to extract data from it.
index a76596dbfbc60486d0f3cfdaee5e2cc4f586c548..5563f3d4f960ab9b874e067093f8f306f2c1dd22 100644 (file)
@@ -128,7 +128,7 @@ public:
   /**
    * Destructor. Only declared to make it @p virtual.
    */
-  virtual ~DataOutStack ();
+  virtual ~DataOutStack () = default;
 
   /**
    * Start the next set of data for a specific parameter value. The argument
index 9a3745ff8f81188a44becbfb6c9f29f2094c1e17..6b22a7683adbe7114ba6d987b9c4c451ab40fc0b 100644 (file)
@@ -430,7 +430,7 @@ public:
    * virtual to ensure that data postprocessors can be destroyed through
    * pointers to the base class.
    */
-  virtual ~DataPostprocessor ();
+  virtual ~DataPostprocessor () = default;
 
   /**
    * This is the main function which actually performs the postprocessing. The
index 99d6b928ae99fdb7cc74ce7daebd23fdb1251961..a5ceb689fa77398df0cacee985280cd8164181f1 100644 (file)
@@ -672,7 +672,7 @@ public:
   /**
    * Destructor. At present, this does nothing.
    */
-  virtual ~TimeStepBase ();
+  virtual ~TimeStepBase () = default;
 
   /**
    * Reconstruct all the data that is needed for this time level to work. This
index 67d159441ec3dd05c49fe1fb07958876cbca10f4..c3b058b20a5a5dc463d8f48620fe8c164451e2fb 100644 (file)
@@ -37,10 +37,6 @@ DEAL_II_NAMESPACE_OPEN
 
 namespace Algorithms
 {
-  OperatorBase::~OperatorBase() = default;
-
-
-
   void OperatorBase::notify(const Event &e)
   {
     notifications += e;
index 579bf18a1d99e97536e5802f721c95299de5d4bb..ef7f6a0e2a0888c23e67037f11f15d6db07094f9 100644 (file)
@@ -38,11 +38,6 @@ AutoDerivativeFunction (const double hh,
 
 
 
-template <int dim>
-AutoDerivativeFunction<dim>::~AutoDerivativeFunction () = default;
-
-
-
 template <int dim>
 void
 AutoDerivativeFunction<dim>::set_formula (const DifferenceFormula form)
index 2aa193206c879e03669e1c7c041a73c46119fcc4..e705dbfb8d8cccaafff0f1c4e4858cb4de56f399 100644 (file)
 
 DEAL_II_NAMESPACE_OPEN
 
-ConvergenceTable::ConvergenceTable() = default;
-
-
-
 void ConvergenceTable::evaluate_convergence_rates(const std::string &data_column_key,
                                                   const std::string &reference_column_key,
                                                   const RateMode     rate_mode,
index 26326ceca925e7c5a9ac3f8047abc05b9c0486cb..5e808e21715759c54337c1068eb1d68c4dfc38a8 100644 (file)
@@ -6383,11 +6383,6 @@ DataOutInterface<dim,spacedim>::DataOutInterface ()
 
 
 
-template <int dim, int spacedim>
-DataOutInterface<dim,spacedim>::~DataOutInterface () = default;
-
-
-
 template <int dim, int spacedim>
 void DataOutInterface<dim,spacedim>::write_dx (std::ostream &out) const
 {
index 893a79bfb8f00319920729bbc1012b628b0fb7c9..2d5e211892339e860ade45ccc498da1188f35ddb 100644 (file)
@@ -37,9 +37,6 @@ namespace Functions
   {}
 
 
-  template <int dim>
-  FlowFunction<dim>::~FlowFunction() = default;
-
 
   template <int dim>
   void
@@ -192,11 +189,6 @@ namespace Functions
 
 
 
-  template <int dim>
-  PoisseuilleFlow<dim>::~PoisseuilleFlow() = default;
-
-
-
   template <int dim>
   void PoisseuilleFlow<dim>::vector_values (
     const std::vector<Point<dim> > &points,
@@ -289,11 +281,6 @@ namespace Functions
 
 
 
-  template <int dim>
-  StokesCosine<dim>::~StokesCosine() = default;
-
-
-
   template <int dim>
   void
   StokesCosine<dim>::set_parameters(const double nu, const double r)
@@ -661,10 +648,6 @@ namespace Functions
 
 
 
-  Kovasznay::~Kovasznay() = default;
-
-
-
   void Kovasznay::vector_values (
     const std::vector<Point<2> > &points,
     std::vector<std::vector<double> > &values) const
index 05cd0b9658b58fac631761e70fd610a20b1654d2..6345390c3487612cb90ccccb8069b5f991b2385e 100644 (file)
@@ -57,6 +57,9 @@ FunctionParser<dim>::FunctionParser(const unsigned int n_components,
 
 
 
+// We deliberately delay the definition of the default constructor
+// so that we don't need to include the definition of mu::Parser
+// in the header file.
 template <int dim>
 FunctionParser<dim>::~FunctionParser() = default;
 
index e2a2f2a7b0e69c6115917815163fbae878622b98..f4949a0f68ea7db24edd248d641d88aa76af22be 100644 (file)
@@ -49,10 +49,6 @@ ParameterHandler::ParameterHandler ()
 
 
 
-ParameterHandler::~ParameterHandler () = default;
-
-
-
 std::string
 ParameterHandler::mangle (const std::string &s)
 {
@@ -2110,10 +2106,6 @@ ParameterHandler::operator == (const ParameterHandler &prm2)  const
 
 
 
-MultipleParameterLoop::UserClass::~UserClass () = default;
-
-
-
 MultipleParameterLoop::MultipleParameterLoop()
   :
   n_branches(0)
@@ -2121,10 +2113,6 @@ MultipleParameterLoop::MultipleParameterLoop()
 
 
 
-MultipleParameterLoop::~MultipleParameterLoop () = default;
-
-
-
 void
 MultipleParameterLoop::parse_input (std::istream &input,
                                     const std::string &filename,
index 3d927962b43a29b736c781350d653b01e50aa08a..7e297d74ddc6ddfd29c3ba061edbe92946f09d26 100644 (file)
@@ -127,10 +127,6 @@ namespace Patterns
 
 
 
-  PatternBase::~PatternBase () = default;
-
-
-
   std::size_t
   PatternBase::memory_consumption () const
   {
@@ -1156,10 +1152,6 @@ namespace Patterns
 
 
 
-  Anything::Anything () = default;
-
-
-
   bool Anything::match (const std::string &) const
   {
     return true;
@@ -1299,10 +1291,6 @@ namespace Patterns
 
 
 
-  DirectoryName::DirectoryName () = default;
-
-
-
   bool DirectoryName::match (const std::string &) const
   {
     return true;
index 486d30a4c078db5817fff6a2398caa51728ac822..a9391015a7c3b1af77913dc004cb765aca65c4a4 100644 (file)
@@ -31,9 +31,6 @@ DEAL_II_NAMESPACE_OPEN
 // inline and template functions
 namespace internal
 {
-  TableEntry::TableEntry () = default;
-
-
   double TableEntry::get_numeric_value () const
   {
     // we don't quite know the data type in 'value', but
index 01e85ddc9beba93e2afc583112d77b7a8177b9c8..91f77b48d433d418313da44f29f4d0b1a71ee5ac 100644 (file)
@@ -227,11 +227,6 @@ namespace parallel
 
 
 
-    template <int dim, int spacedim>
-    Triangulation<dim,spacedim>::~Triangulation () = default;
-
-
-
     template <int dim, int spacedim>
     void
     Triangulation<dim,spacedim>::execute_coarsening_and_refinement ()
index 4cf08c0b16abc94e74dca6a1aeaf3fa9cb942501..5e7c3ddeab34bab3873953561fa47964d4217896 100644 (file)
@@ -56,11 +56,6 @@ namespace parallel
 
 
 
-    template <int dim, typename VectorType, typename DoFHandlerType>
-    SolutionTransfer<dim, VectorType, DoFHandlerType>::~SolutionTransfer () = default;
-
-
-
     template <int dim, typename VectorType, typename DoFHandlerType>
     void
     SolutionTransfer<dim, VectorType, DoFHandlerType>::
index ea80d956eb08f9e3d7c8591c5da2d02ba5f2b45f..0d66d767db4284335b70db9e2007f28c10a13134 100644 (file)
@@ -41,11 +41,6 @@ FiniteElement<dim, spacedim>::InternalDataBase::InternalDataBase ():
 
 
 
-template <int dim, int spacedim>
-FiniteElement<dim,spacedim>::InternalDataBase::~InternalDataBase () = default;
-
-
-
 template <int dim, int spacedim>
 std::size_t
 FiniteElement<dim, spacedim>::InternalDataBase::memory_consumption () const
@@ -160,10 +155,6 @@ 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 102ede8580625f01f7996948d1a1a4008289f5cc..5dafb591d0e8932a13768d27a42e6adc1dfb7fae 100644 (file)
@@ -73,10 +73,6 @@ std::unique_ptr<FiniteElement<2,2>>
 
 
 
-FE_P1NC::~FE_P1NC () = default;
-
-
-
 std::vector<unsigned int>
 FE_P1NC::get_dpo_vector ()
 {
index 7d3abc04af3f3f040e18cf16ee4594177e0c2cde..e85fe0adc0ded08741b42edef21f411806ebdd94 100644 (file)
@@ -2130,7 +2130,7 @@ public:
    * pointers to the base
    * class.
    */
-  virtual ~CellIteratorBase ();
+  virtual ~CellIteratorBase () = default;
 
   /**
    * Conversion operator to an
@@ -2171,10 +2171,6 @@ public:
                                Vector<IndexSet::value_type> &out) const = 0;
 };
 
-
-template <int dim, int spacedim>
-FEValuesBase<dim,spacedim>::CellIteratorBase::~CellIteratorBase () = default;
-
 /* ---------------- classes derived from FEValuesBase<dim,spacedim>::CellIteratorBase --------- */
 
 
index e4299517479cb50240d7b56657d3b526fcea4625..ced110270192dec19324dad7931e0514f84898bc 100644 (file)
 DEAL_II_NAMESPACE_OPEN
 
 
-template <int dim, int spacedim>
-Mapping<dim, spacedim>::~Mapping () = default;
-
-
 template <int dim, int spacedim>
 std::array<Point<spacedim>, GeometryInfo<dim>::vertices_per_cell>
 Mapping<dim, spacedim>::get_vertices (
@@ -85,11 +81,6 @@ Mapping<dim, spacedim>::InternalDataBase::InternalDataBase ():
 
 
 
-template <int dim, int spacedim>
-Mapping<dim, spacedim>::InternalDataBase::~InternalDataBase () = default;
-
-
-
 template <int dim, int spacedim>
 std::size_t
 Mapping<dim, spacedim>::InternalDataBase::memory_consumption () const
index 4a67770d78ca3af77fff58394884e3fdd414e5da..c0af351c5d8eb80b2c38f93fb192ab2ff30c94db 100644 (file)
 
 DEAL_II_NAMESPACE_OPEN
 
-template <int dim, int spacedim>
-MappingManifold<dim,spacedim>::InternalData::InternalData () = default;
-
-
 template <int dim, int spacedim>
 std::size_t
 MappingManifold<dim,spacedim>::InternalData::memory_consumption () const
@@ -173,11 +169,6 @@ initialize_face (const UpdateFlags      update_flags,
 
 
 
-template <int dim, int spacedim>
-MappingManifold<dim,spacedim>::MappingManifold () = default;
-
-
-
 template <int dim, int spacedim>
 MappingManifold<dim,spacedim>::MappingManifold (const MappingManifold<dim,spacedim> &)
 {}
index 6a23eea84a59a2474ff3cbc092e9c0bb86a169c9..5b9c0abe33a284ebcfedf48a03f3baf0456712fa 100644 (file)
@@ -30,11 +30,6 @@ DEAL_II_NAMESPACE_OPEN
 using namespace Manifolds;
 
 /* -------------------------- Manifold --------------------- */
-template <int dim, int spacedim>
-Manifold<dim, spacedim>::~Manifold () = default;
-
-
-
 template <int dim, int spacedim>
 Point<spacedim>
 Manifold<dim, spacedim>::
@@ -690,12 +685,6 @@ FlatManifold<dim, spacedim>::get_tangent_vector (const Point<spacedim> &x1,
 
 
 /* -------------------------- ChartManifold --------------------- */
-
-template <int dim, int spacedim, int chartdim>
-ChartManifold<dim,spacedim,chartdim>::~ChartManifold () = default;
-
-
-
 template <int dim, int spacedim, int chartdim>
 ChartManifold<dim,spacedim,chartdim>::ChartManifold (const Tensor<1,chartdim> &periodicity)
   :
index 09803476453a518fbada76e6c96750a87ec9690f..69364fdd6dd902a5566bf5626e8134aaee5e096a 100644 (file)
@@ -56,11 +56,6 @@ PersistentTriangulation (const PersistentTriangulation<dim,spacedim> &old_tria)
 
 
 
-template <int dim, int spacedim>
-PersistentTriangulation<dim,spacedim>::~PersistentTriangulation () = default;
-
-
-
 template <int dim, int spacedim>
 void
 PersistentTriangulation<dim,spacedim>::execute_coarsening_and_refinement ()
index ead4d8368174dcbdb887088a9b604c70a81f2c67..aa13cfb072ace865a82b5efb21570d988c18fe00 100644 (file)
@@ -28,10 +28,6 @@ DEAL_II_NAMESPACE_OPEN
 /* -------------------------- Boundary --------------------- */
 
 
-template <int dim, int spacedim>
-Boundary<dim, spacedim>::~Boundary () = default;
-
-
 template <int dim, int spacedim>
 void
 Boundary<dim, spacedim>::
@@ -185,10 +181,6 @@ get_line_support_points (const unsigned int n_intermediate_points) const
 /* -------------------------- StraightBoundary --------------------- */
 
 
-template <int dim, int spacedim>
-StraightBoundary<dim, spacedim>::StraightBoundary () = default;
-
-
 template <int dim, int spacedim>
 Point<spacedim>
 StraightBoundary<dim, spacedim>::
index 0892432c831f82a05ed0956b932e82a562d7eda0..2dbf17f50c56cd932e7db034c7bc195fcde730be 100644 (file)
@@ -86,9 +86,6 @@ namespace hp
     return numbers::invalid_unsigned_int;
   }
 
-  template <int dim, int spacedim>
-  FECollection<dim,spacedim>::FECollection () = default;
-
 
 
   template <int dim, int spacedim>
index 3b3e1705ebe6008ca14050fffe73403af1fc8454..16bc81ec3dcd1b41c2418e23c652b719e4bd6aa6 100644 (file)
@@ -22,12 +22,6 @@ DEAL_II_NAMESPACE_OPEN
 
 namespace hp
 {
-
-  template <int dim, int spacedim>
-  MappingCollection<dim,spacedim>::MappingCollection () = default;
-
-
-
   template <int dim, int spacedim>
   MappingCollection<dim,spacedim>::
   MappingCollection (const Mapping<dim,spacedim> &mapping)
index 248e578261a0070ec0befb899e83c28e931f607c..d90f2fadc6217593cbb5bc7de5457d9377efc85d 100644 (file)
@@ -327,10 +327,6 @@ BlockSparsityPatternBase<SparsityPatternBase>::print_gnuplot(std::ostream &out)
 
 
 
-BlockSparsityPattern::BlockSparsityPattern () = default;
-
-
-
 BlockSparsityPattern::BlockSparsityPattern (const size_type n_rows,
                                             const size_type n_columns)
   :
@@ -420,11 +416,6 @@ BlockSparsityPattern::copy_from  (const BlockDynamicSparsityPattern &dsp)
 
 
 
-
-BlockDynamicSparsityPattern::BlockDynamicSparsityPattern () = default;
-
-
-
 BlockDynamicSparsityPattern::
 BlockDynamicSparsityPattern (const size_type n_rows,
                              const size_type n_columns)
@@ -518,10 +509,6 @@ BlockDynamicSparsityPattern::reinit (
 namespace TrilinosWrappers
 {
 
-  BlockSparsityPattern::BlockSparsityPattern () = default;
-
-
-
   BlockSparsityPattern::
   BlockSparsityPattern (const size_type n_rows,
                         const size_type n_columns)
index 1b77f41b347dfc4479df62a4651198ac5955229c..4efe4b6e05965ef6c3a970da0a0f4c684b06dee5 100644 (file)
@@ -91,10 +91,6 @@ ChunkSparsityPattern::ChunkSparsityPattern (
 
 
 
-ChunkSparsityPattern::~ChunkSparsityPattern () = default;
-
-
-
 ChunkSparsityPattern &
 ChunkSparsityPattern::operator = (const ChunkSparsityPattern &s)
 {
index 12d39c1b871170297918b813aeda48cbde691ece..6a06a82a5dd266893fa8aaffcd1ffd710f1299df 100644 (file)
@@ -29,10 +29,6 @@ MatrixOut::Options::Options (const bool         show_absolute_values,
 
 
 
-MatrixOut::~MatrixOut () = default;
-
-
-
 const std::vector<MatrixOut::Patch> &
 MatrixOut::get_patches () const
 {
index b07a42d4a4822b019a53e92206baee055e17a24e..b957ee6d559aac18ef77668fe92c5856788ecae5 100644 (file)
@@ -24,12 +24,6 @@ namespace PETScWrappers
   namespace MPI
   {
 
-    BlockSparseMatrix::BlockSparseMatrix () = default;
-
-
-    BlockSparseMatrix::~BlockSparseMatrix () = default;
-
-
     BlockSparseMatrix &
     BlockSparseMatrix::operator = (const BlockSparseMatrix &m)
     {
index 93e72acc4225951b826626b49c45a344eca540d4..e14cc07c0fef6564d8d123d70cdd4cb726576a59 100644 (file)
@@ -123,8 +123,6 @@ namespace PETScWrappers
   }
 
 
-  PreconditionJacobi::PreconditionJacobi () = default;
-
 
   PreconditionJacobi::PreconditionJacobi (const MatrixBase     &matrix,
                                           const AdditionalData &additional_data)
@@ -174,8 +172,6 @@ namespace PETScWrappers
   }
 
 
-  PreconditionBlockJacobi::PreconditionBlockJacobi () = default;
-
 
   PreconditionBlockJacobi::
   PreconditionBlockJacobi (const MatrixBase     &matrix,
@@ -221,8 +217,6 @@ namespace PETScWrappers
   {}
 
 
-  PreconditionSOR::PreconditionSOR () = default;
-
 
   PreconditionSOR::PreconditionSOR (const MatrixBase     &matrix,
                                     const AdditionalData &additional_data)
@@ -266,8 +260,6 @@ namespace PETScWrappers
   {}
 
 
-  PreconditionSSOR::PreconditionSSOR () = default;
-
 
   PreconditionSSOR::PreconditionSSOR (const MatrixBase     &matrix,
                                       const AdditionalData &additional_data)
@@ -315,8 +307,6 @@ namespace PETScWrappers
   {}
 
 
-  PreconditionEisenstat::PreconditionEisenstat () = default;
-
 
   PreconditionEisenstat::PreconditionEisenstat (const MatrixBase     &matrix,
                                                 const AdditionalData &additional_data)
@@ -361,8 +351,6 @@ namespace PETScWrappers
   {}
 
 
-  PreconditionICC::PreconditionICC () = default;
-
 
   PreconditionICC::PreconditionICC (const MatrixBase     &matrix,
                                     const AdditionalData &additional_data)
@@ -406,8 +394,6 @@ namespace PETScWrappers
   {}
 
 
-  PreconditionILU::PreconditionILU () = default;
-
 
   PreconditionILU::PreconditionILU (const MatrixBase     &matrix,
                                     const AdditionalData &additional_data)
@@ -460,7 +446,6 @@ namespace PETScWrappers
   {}
 
 
-  PreconditionBoomerAMG::PreconditionBoomerAMG () = default;
 
   PreconditionBoomerAMG::PreconditionBoomerAMG (const MPI_Comm comm,
                                                 const AdditionalData &additional_data_)
@@ -578,8 +563,6 @@ namespace PETScWrappers
   {}
 
 
-  PreconditionParaSails::PreconditionParaSails () = default;
-
 
   PreconditionParaSails::PreconditionParaSails (const MatrixBase     &matrix,
                                                 const AdditionalData &additional_data)
@@ -673,9 +656,6 @@ namespace PETScWrappers
 
   /* ----------------- PreconditionNone ------------------------- */
 
-  PreconditionNone::PreconditionNone () = default;
-
-
   PreconditionNone::PreconditionNone (const MatrixBase     &matrix,
                                       const AdditionalData &additional_data)
   {
@@ -718,8 +698,6 @@ namespace PETScWrappers
   {}
 
 
-  PreconditionLU::PreconditionLU () = default;
-
 
   PreconditionLU::PreconditionLU (const MatrixBase     &matrix,
                                   const AdditionalData &additional_data)
index 15f0d8752334a434255a434d95ad26e8ad816134..a29052b6e0b95a370eb1f00b5b542c391f1d23d4 100644 (file)
@@ -49,10 +49,6 @@ namespace PETScWrappers
 
 
 
-  SolverBase::~SolverBase () = default;
-
-
-
   void
   SolverBase::solve (const MatrixBase         &A,
                      VectorBase               &x,
index 4533df2a72acbec7c89b4185aaeb922f087b9ce4..7ced6c6bdfd840ad12f4ae2f4c12b1d848c01742 100644 (file)
@@ -48,10 +48,6 @@ SolverControl::SolverControl (const unsigned int maxiter,
 
 
 
-SolverControl::~SolverControl() = default;
-
-
-
 SolverControl::State
 SolverControl::check (const unsigned int step,
                       const double check_value)
@@ -258,8 +254,6 @@ ReductionControl::operator= (const SolverControl &c)
 }
 
 
-ReductionControl::~ReductionControl() = default;
-
 
 SolverControl::State
 ReductionControl::check (const unsigned int step,
@@ -322,7 +316,6 @@ IterationNumberControl::IterationNumberControl(const unsigned int n,
   SolverControl (n, tolerance, m_log_history, m_log_result) {}
 
 
-IterationNumberControl::~IterationNumberControl() = default;
 
 
 SolverControl::State
@@ -385,9 +378,6 @@ ConsecutiveControl::operator= (const SolverControl &c)
 
 
 
-ConsecutiveControl::~ConsecutiveControl() = default;
-
-
 SolverControl::State
 ConsecutiveControl::check (const unsigned int step,
                            const double check_value)
index 26ba1d38baef2f2bc4c5674d44ffd8ee581417b5..e552f927defe9dcd0dc4bb5babb3903a9f7dfdc5 100644 (file)
@@ -24,10 +24,6 @@ DEAL_II_NAMESPACE_OPEN
 
 namespace TrilinosWrappers
 {
-  BlockSparseMatrix::BlockSparseMatrix () = default;
-
-
-
   BlockSparseMatrix::~BlockSparseMatrix ()
   {
     // delete previous content of
@@ -42,11 +38,6 @@ namespace TrilinosWrappers
 
 
 
-  BlockSparseMatrix &
-  BlockSparseMatrix::operator = (const BlockSparseMatrix &m) = default;
-
-
-
   void
   BlockSparseMatrix::
   reinit (const size_type n_block_rows,
index 5d6f636c7ed1abe9de20f51b76bcecf9069b112b..7bbec17d3eb4b1720e908352c63391ced84202dc 100644 (file)
@@ -67,11 +67,6 @@ namespace TrilinosWrappers
 
 
 
-
-    BlockVector::~BlockVector () = default;
-
-
-
     void
     BlockVector::reinit (const std::vector<IndexSet> &parallel_partitioning,
                          const MPI_Comm              &communicator,
index 77569930652e627e884a0ba36bbca4e5f18ad1b1..d8cc956f8d04baafa325910f9b9b218b98736eab 100644 (file)
@@ -55,10 +55,6 @@ namespace TrilinosWrappers
 
 
 
-  PreconditionBase::~PreconditionBase() = default;
-
-
-
   void PreconditionBase::clear ()
   {
     preconditioner.reset();
index 7cd95fca82371c2feee796727de16716ff2e56df..2839e10dc26ef83187f60072a8fc5a0dc9c8c101 100644 (file)
@@ -68,10 +68,6 @@ namespace TrilinosWrappers
 
 
 
-  SolverBase::~SolverBase () = default;
-
-
-
   SolverControl &
   SolverBase::control() const
   {
@@ -721,10 +717,6 @@ namespace TrilinosWrappers
 
 
 
-  SolverDirect::~SolverDirect () = default;
-
-
-
   SolverControl &
   SolverDirect::control() const
   {
index 2aa484d0768120e0105727d9cf117f7cc9ce7db7..af8c0d3aae4cea470b86b876e92613dd7702e861 100644 (file)
@@ -356,10 +356,6 @@ namespace TrilinosWrappers
 
 
 
-  SparseMatrix::~SparseMatrix () = default;
-
-
-
   void
   SparseMatrix::copy_from (const SparseMatrix &rhs)
   {
@@ -2699,11 +2695,6 @@ namespace TrilinosWrappers
 
 
 
-      // Destructor
-      TrilinosPayload::~TrilinosPayload () = default;
-
-
-
       TrilinosPayload
       TrilinosPayload::identity_payload () const
       {
index 5e09df631acf30340d614730e5082f3e162a0025..75284615bb79b67248f2e4ddb6e52b6b20421fd6 100644 (file)
@@ -221,10 +221,6 @@ namespace TrilinosWrappers
 
 
 
-  SparsityPattern::~SparsityPattern () = default;
-
-
-
   void
   SparsityPattern::reinit (const size_type  m,
                            const size_type  n,
index bcdcbbf52c154bbdcc037203ee711f84e054a674..5e1d7041fbbb4c9bc22598afd76fad724b0bcfbe 100644 (file)
@@ -130,10 +130,6 @@ namespace TrilinosWrappers
 
 
 
-    Vector::~Vector () = default;
-
-
-
     void
     Vector::clear ()
     {
index 46251ade0772d116a83d53fc29c014f05ca5a375..bdf6da91801c7e914f96a5c30b809f6196f45384 100644 (file)
@@ -71,8 +71,6 @@ namespace MeshWorker
   {}
 
 
-  template <int dim, int spacedim, typename number>
-  LocalIntegrator<dim, spacedim, number>::~LocalIntegrator () = default;
 
   template <int dim, int spacedim, typename number>
   void
index b4e6bab9d4f819d5065d8916290b7b70237a5f0c..9ee558cb82013ec936fd7ffed73fc3e07dc0bc46 100644 (file)
 DEAL_II_NAMESPACE_OPEN
 
 
-template <typename VectorType>
-MGTransferBase<VectorType>::~MGTransferBase() = default;
-
-
-template <typename VectorType>
-MGMatrixBase<VectorType>::~MGMatrixBase() = default;
-
-
-template <typename VectorType>
-MGSmootherBase<VectorType>::~MGSmootherBase() = default;
-
-
 template <typename VectorType>
 void
 MGSmootherBase<VectorType>::apply (const unsigned int level,
@@ -50,10 +38,6 @@ MGSmootherBase<VectorType>::apply (const unsigned int level,
 }
 
 
-template <typename VectorType>
-MGCoarseGridBase<VectorType>::~MGCoarseGridBase() = default;
-
-
 // Explicit instantiations
 
 #include "mg_base.inst"
index 0e9c7583fc20bd7964806b805471bdb68e0ffc08..6ec3952ea540637efcc2f71334bfd42acf019e42 100644 (file)
@@ -58,11 +58,6 @@ MGTransferMatrixFree<dim,Number>::MGTransferMatrixFree (const MGConstrainedDoFs
 
 
 
-template <int dim, typename Number>
-MGTransferMatrixFree<dim,Number>::~MGTransferMatrixFree () = default;
-
-
-
 template <int dim, typename Number>
 void MGTransferMatrixFree<dim,Number>::initialize_constraints
 (const MGConstrainedDoFs &mg_c)
@@ -552,10 +547,6 @@ MGTransferMatrixFree<dim,Number>::memory_consumption() const
 }
 
 
-template <int dim, typename Number>
-MGTransferBlockMatrixFree<dim,Number>::MGTransferBlockMatrixFree () = default;
-
-
 
 template <int dim, typename Number>
 MGTransferBlockMatrixFree<dim,Number>::MGTransferBlockMatrixFree (const MGConstrainedDoFs &mg_c)
@@ -566,11 +557,6 @@ MGTransferBlockMatrixFree<dim,Number>::MGTransferBlockMatrixFree (const MGConstr
 
 
 
-template <int dim, typename Number>
-MGTransferBlockMatrixFree<dim,Number>::~MGTransferBlockMatrixFree () = default;
-
-
-
 template <int dim, typename Number>
 void MGTransferBlockMatrixFree<dim,Number>::initialize_constraints
 (const MGConstrainedDoFs &mg_c)
index 1e2a68b185132926f0a34becd95173390aa63ea4..e9b3e25b0aa8048bf4ec121ff646b36eb7462579 100644 (file)
 DEAL_II_NAMESPACE_OPEN
 
 
-template <typename VectorType>
-MGTransferPrebuilt<VectorType>::MGTransferPrebuilt () = default;
-
-
-
 template <typename VectorType>
 MGTransferPrebuilt<VectorType>::MGTransferPrebuilt (const MGConstrainedDoFs &mg_c)
 {
@@ -61,11 +56,6 @@ MGTransferPrebuilt<VectorType>::MGTransferPrebuilt (const ConstraintMatrix &/*c*
 
 
 
-template <typename VectorType>
-MGTransferPrebuilt<VectorType>::~MGTransferPrebuilt () = default;
-
-
-
 template <typename VectorType>
 void MGTransferPrebuilt<VectorType>::initialize_constraints
 (const MGConstrainedDoFs &mg_c)
index 65c56843c028011838afae7427ba2ec4832c35bf..86c8c5fd4ae7ad8995f8213de17a1ad0143573e7 100644 (file)
@@ -214,8 +214,6 @@ MGTransferSelect<number>::MGTransferSelect (const ConstraintMatrix &c)
   constraints(&c)
 {}
 
-template <typename number>
-MGTransferSelect<number>::~MGTransferSelect () = default;
 
 
 template <typename number>
@@ -278,11 +276,6 @@ MGTransferBlockSelect<number>::MGTransferBlockSelect (const ConstraintMatrix &/*
 
 
 
-template <typename number>
-MGTransferBlockSelect<number>::~MGTransferBlockSelect () = default;
-
-
-
 template <typename number>
 void
 MGTransferBlockSelect<number>::prolongate (const unsigned int   to_level,
index eab0961801d5c3dab447c52fa21640a024cf61bc..1e748e51d3f6416a230a001db08325c81f6ded88 100644 (file)
@@ -41,10 +41,6 @@ DataOutStack<dim,spacedim,DoFHandlerType>::DataVector::memory_consumption () con
 
 
 
-template <int dim, int spacedim, typename DoFHandlerType>
-DataOutStack<dim,spacedim,DoFHandlerType>::~DataOutStack () = default;
-
-
 template <int dim, int spacedim, typename DoFHandlerType>
 void DataOutStack<dim,spacedim,DoFHandlerType>::new_parameter_value (const double p,
     const double dp)
index 1ded8ae43462ddef035de3567386d4855e903274..1175bb5e121d2a15f128ce5c2be27880bc30e514 100644 (file)
@@ -21,11 +21,6 @@ DEAL_II_NAMESPACE_OPEN
 
 // -------------------------- DataPostprocessor ---------------------------
 
-template <int dim>
-DataPostprocessor<dim>::~DataPostprocessor() = default;
-
-
-
 template <int dim>
 void
 DataPostprocessor<dim>::
index bb979f04c7922a082201b480fe3b0b185665d98c..517c8b3059b37f2b79056c641c7e6594c403f0ec 100644 (file)
@@ -264,10 +264,6 @@ TimeStepBase::TimeStepBase (const double time) :
 
 
 
-TimeStepBase::~TimeStepBase () = default;
-
-
-
 void
 TimeStepBase::wake_up (const unsigned int )
 {}

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.