]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Be explicit about virtual functions called in constructors and destructors
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Sat, 13 Jan 2018 13:53:04 +0000 (14:53 +0100)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Sat, 13 Jan 2018 20:51:50 +0000 (21:51 +0100)
14 files changed:
include/deal.II/base/time_stepping.templates.h
include/deal.II/lac/block_sparse_matrix.templates.h
include/deal.II/lac/chunk_sparse_matrix.templates.h
include/deal.II/lac/read_write_vector.h
include/deal.II/lac/sparse_decomposition.templates.h
include/deal.II/lac/sparse_matrix.templates.h
include/deal.II/lac/sparse_mic.templates.h
include/deal.II/lac/vector.h
include/deal.II/numerics/data_out_dof_data.templates.h
source/distributed/tria.cc
source/dofs/dof_handler.cc
source/hp/dof_handler.cc
source/lac/petsc_parallel_vector.cc
source/lac/trilinos_epetra_communication_pattern.cc

index c3f0cfd4bdd5c728f98a3e5be7bdf768e99695a5..f2744ab35ba436a32a4bf8ea64cd3b7513fc5150 100644 (file)
@@ -55,7 +55,7 @@ namespace TimeStepping
   template <typename VectorType>
   ExplicitRungeKutta<VectorType>::ExplicitRungeKutta(const runge_kutta_method method)
   {
-    initialize(method);
+    ExplicitRungeKutta<VectorType>::initialize(method);
   }
 
 
@@ -211,7 +211,7 @@ namespace TimeStepping
     max_it(max_it),
     tolerance(tolerance)
   {
-    initialize(method);
+    ImplicitRungeKutta<VectorType>::initialize(method);
   }
 
 
@@ -417,7 +417,7 @@ namespace TimeStepping
     last_same_as_first(false),
     last_stage(nullptr)
   {
-    initialize(method);
+    EmbeddedExplicitRungeKutta<VectorType>::initialize(method);
   }
 
 
index 01bae4345fa294e3eade1208e3c57d62afe09760..8a0d2e6eaae3488cd2c87eeb1c3a78a658aedd03 100644 (file)
@@ -27,7 +27,7 @@ template <typename number>
 BlockSparseMatrix<number>::
 BlockSparseMatrix (const BlockSparsityPattern &sparsity)
 {
-  reinit (sparsity);
+  BlockSparseMatrix<number>::reinit (sparsity);
 }
 
 
index 26d5e20a3363546a7d57b47057b4789a6618930b..99d78af94929a2687530a3f2c85482cd8b409a1c 100644 (file)
@@ -332,7 +332,7 @@ ChunkSparseMatrix<number>::ChunkSparseMatrix (const ChunkSparsityPattern &c)
   val(nullptr),
   max_len(0)
 {
-  reinit (c);
+  ChunkSparseMatrix<number>::reinit (c);
 }
 
 
@@ -349,7 +349,7 @@ ChunkSparseMatrix<number>::ChunkSparseMatrix (const ChunkSparsityPattern &c,
   Assert (c.n_rows() == id.m(), ExcDimensionMismatch (c.n_rows(), id.m()));
   Assert (c.n_cols() == id.n(), ExcDimensionMismatch (c.n_cols(), id.n()));
 
-  reinit (c);
+  ChunkSparseMatrix<number>::reinit (c);
   for (size_type i=0; i<n(); ++i)
     this->set(i,i,1.);
 }
index 05c72f98eedd198be369d1a2a34c9da277cbf433..9b959c99205f1f7fa19a845e8c778e6fff5aefd4 100644 (file)
@@ -673,7 +673,7 @@ namespace LinearAlgebra
     :
     val(nullptr)
   {
-    reinit(0, true);
+    ReadWriteVector<Number>::reinit(0, true);
   }
 
 
@@ -696,7 +696,7 @@ namespace LinearAlgebra
     :
     val(nullptr)
   {
-    reinit (size, false);
+    ReadWriteVector<Number>::reinit (size, false);
   }
 
 
@@ -707,7 +707,7 @@ namespace LinearAlgebra
     :
     val(nullptr)
   {
-    reinit (locally_stored_indices);
+    ReadWriteVector<Number>::reinit (locally_stored_indices);
   }
 
 
index 027d97575e43f3ec9058c966f3da6b1d19efcbfc..d5d373302bc4d70d9fe41529ab31be61afa90593 100644 (file)
@@ -40,7 +40,7 @@ SparseLUDecomposition<number>::SparseLUDecomposition()
 template <typename number>
 SparseLUDecomposition<number>::~SparseLUDecomposition()
 {
-  clear();
+  SparseLUDecomposition<number>::clear();
 }
 
 
index 53cfc4452044bc1b8f471a9f4c55aa2bf746825b..1fe0e27462a9d21ae77cbec7d0315f297720f702 100644 (file)
@@ -126,7 +126,7 @@ SparseMatrix<number>::SparseMatrix (const SparsityPattern &c)
   val(nullptr),
   max_len(0)
 {
-  reinit (c);
+  SparseMatrix<number>::reinit (c);
 }
 
 
@@ -143,7 +143,7 @@ SparseMatrix<number>::SparseMatrix (const SparsityPattern &c,
   Assert (c.n_rows() == id.m(), ExcDimensionMismatch (c.n_rows(), id.m()));
   Assert (c.n_cols() == id.n(), ExcDimensionMismatch (c.n_cols(), id.n()));
 
-  reinit (c);
+  SparseMatrix<number>::reinit (c);
   for (size_type i=0; i<n(); ++i)
     this->set(i,i,1.);
 }
index c00e41f6227f164b32044fc006d5aee6c331f871..3aaa7cc0c54c901b9a4cdd4bac791f4b3bb45544 100644 (file)
@@ -36,7 +36,7 @@ SparseMIC<number>::SparseMIC ()
 template <typename number>
 SparseMIC<number>::~SparseMIC()
 {
-  clear();
+  SparseMIC<number>::clear();
 }
 
 
index 7e712c095b088cf4b5406c21c3b118cafed500e9..410f72ce7406a2378236d8ba92357e365ed0334d 100644 (file)
@@ -978,7 +978,7 @@ Vector<Number>::Vector ()
   max_vec_size(0),
   values(nullptr, &free)
 {
-  reinit(0);
+  Vector<Number>::reinit(0);
 }
 
 
@@ -1007,7 +1007,7 @@ Vector<Number>::Vector (const size_type n)
   max_vec_size(0),
   values(nullptr, &free)
 {
-  reinit (n, false);
+  Vector<Number>::reinit (n, false);
 }
 
 
index 50f089419e1fbcdba319a7f1a2f627801ea11d1f..1ce80a4c8a3a3161b8ba2ea6086b25ca679d0855 100644 (file)
@@ -897,7 +897,7 @@ DataOut_DoFData<DoFHandlerType,patch_dim,patch_space_dim>::DataOut_DoFData ()
 template <typename DoFHandlerType, int patch_dim, int patch_space_dim>
 DataOut_DoFData<DoFHandlerType,patch_dim,patch_space_dim>::~DataOut_DoFData ()
 {
-  clear ();
+  DataOut_DoFData<DoFHandlerType,patch_dim,patch_space_dim>::clear ();
 }
 
 
index 532ef242629ea5490d87160ee37a23f07421dabe..a7c9f0e7dba78da24e6290a166764dc995e58ab3 100644 (file)
@@ -1304,7 +1304,7 @@ namespace parallel
     template <int dim, int spacedim>
     Triangulation<dim,spacedim>::~Triangulation ()
     {
-      clear ();
+      Triangulation<dim, spacedim>::clear ();
 
       Assert (triangulation_has_content == false,
               ExcInternalError());
index deb6abb60ea5a3099afbd7d9f664617c85ca61a7..459c28a666c1033be122223e6962da924e3a1377 100644 (file)
@@ -683,7 +683,7 @@ template <int dim, int spacedim>
 DoFHandler<dim,spacedim>::~DoFHandler ()
 {
   // release allocated memory
-  clear ();
+  DoFHandler<dim, spacedim>::clear ();
 
   // also release the policy. this needs to happen before the
   // current object disappears because the policy objects
index 12a486eea9181f31dc6bfc9a766ffd3f06cbcdba..9bf68c62cf454f0590e2f3c01688b39fdf4b47be 100644 (file)
@@ -1009,7 +1009,7 @@ namespace hp
     tria_listeners.clear ();
 
     // ...and release allocated memory
-    clear ();
+    DoFHandler<dim, spacedim>::clear ();
   }
 
 
index d9911e9c2421dddbaf3c2fbecd56e690cd3cf7c3..81187f91b90cc2591e6ded252e50a7ebe48f9d7a 100644 (file)
@@ -31,7 +31,7 @@ namespace PETScWrappers
     Vector::Vector ()
       : communicator (MPI_COMM_SELF)
     {
-      create_vector(0, 0);
+      Vector::create_vector(0, 0);
     }
 
 
index 63ca267c2f15c3c09c355677b03d69a36a717493..c652bfda915a0ec8a198cffeb605161f38782760 100644 (file)
@@ -37,7 +37,7 @@ namespace LinearAlgebra
                                                const IndexSet &read_write_vector_index_set,
                                                const MPI_Comm &communicator)
     {
-      reinit(vector_space_vector_index_set, read_write_vector_index_set, communicator);
+      CommunicationPattern::reinit(vector_space_vector_index_set, read_write_vector_index_set, communicator);
     }
 
 

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.