]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Add comments 5728/head
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Sun, 14 Jan 2018 22:59:01 +0000 (23:59 +0100)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Sun, 14 Jan 2018 22:59:01 +0000 (23:59 +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 f2744ab35ba436a32a4bf8ea64cd3b7513fc5150..bb29c7bdd29c9445a43bd56bc3ea30378f7c8952 100644 (file)
@@ -55,6 +55,9 @@ namespace TimeStepping
   template <typename VectorType>
   ExplicitRungeKutta<VectorType>::ExplicitRungeKutta(const runge_kutta_method method)
   {
+    // virtual functions called in constructors and destructors never use the
+    // override in a derived class
+    // for clarity be explicit on which function is called
     ExplicitRungeKutta<VectorType>::initialize(method);
   }
 
@@ -211,6 +214,9 @@ namespace TimeStepping
     max_it(max_it),
     tolerance(tolerance)
   {
+    // virtual functions called in constructors and destructors never use the
+    // override in a derived class
+    // for clarity be explicit on which function is called
     ImplicitRungeKutta<VectorType>::initialize(method);
   }
 
@@ -417,6 +423,9 @@ namespace TimeStepping
     last_same_as_first(false),
     last_stage(nullptr)
   {
+    // virtual functions called in constructors and destructors never use the
+    // override in a derived class
+    // for clarity be explicit on which function is called
     EmbeddedExplicitRungeKutta<VectorType>::initialize(method);
   }
 
index 8a0d2e6eaae3488cd2c87eeb1c3a78a658aedd03..33b86621ebb7ec97f0ba8c791da340c6181b3ddf 100644 (file)
@@ -27,6 +27,9 @@ template <typename number>
 BlockSparseMatrix<number>::
 BlockSparseMatrix (const BlockSparsityPattern &sparsity)
 {
+  // virtual functions called in constructors and destructors never use the
+  // override in a derived class
+  // for clarity be explicit on which function is called
   BlockSparseMatrix<number>::reinit (sparsity);
 }
 
index 99d78af94929a2687530a3f2c85482cd8b409a1c..d90363c9323e90037870ad5312763c03d5449382 100644 (file)
@@ -332,6 +332,9 @@ ChunkSparseMatrix<number>::ChunkSparseMatrix (const ChunkSparsityPattern &c)
   val(nullptr),
   max_len(0)
 {
+  // virtual functions called in constructors and destructors never use the
+  // override in a derived class
+  // for clarity be explicit on which function is called
   ChunkSparseMatrix<number>::reinit (c);
 }
 
@@ -349,6 +352,9 @@ 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()));
 
+  // virtual functions called in constructors and destructors never use the
+  // override in a derived class
+  // for clarity be explicit on which function is called
   ChunkSparseMatrix<number>::reinit (c);
   for (size_type i=0; i<n(); ++i)
     this->set(i,i,1.);
index 9b959c99205f1f7fa19a845e8c778e6fff5aefd4..6d0f8d110943cff81f60ea6f6adfb968b352cf6e 100644 (file)
@@ -673,6 +673,9 @@ namespace LinearAlgebra
     :
     val(nullptr)
   {
+    // virtual functions called in constructors and destructors never use the
+    // override in a derived class
+    // for clarity be explicit on which function is called
     ReadWriteVector<Number>::reinit(0, true);
   }
 
@@ -696,6 +699,9 @@ namespace LinearAlgebra
     :
     val(nullptr)
   {
+    // virtual functions called in constructors and destructors never use the
+    // override in a derived class
+    // for clarity be explicit on which function is called
     ReadWriteVector<Number>::reinit (size, false);
   }
 
@@ -707,6 +713,9 @@ namespace LinearAlgebra
     :
     val(nullptr)
   {
+    // virtual functions called in constructors and destructors never use the
+    // override in a derived class
+    // for clarity be explicit on which function is called
     ReadWriteVector<Number>::reinit (locally_stored_indices);
   }
 
index d5d373302bc4d70d9fe41529ab31be61afa90593..79d912c61785fa179602d09cfe99f9a151acdef5 100644 (file)
@@ -40,6 +40,9 @@ SparseLUDecomposition<number>::SparseLUDecomposition()
 template <typename number>
 SparseLUDecomposition<number>::~SparseLUDecomposition()
 {
+  // virtual functions called in constructors and destructors never use the
+  // override in a derived class
+  // for clarity be explicit on which function is called
   SparseLUDecomposition<number>::clear();
 }
 
index 1fe0e27462a9d21ae77cbec7d0315f297720f702..6dc48ca3540307cd7c62e2588e5b5f4ac962bbe7 100644 (file)
@@ -126,6 +126,9 @@ SparseMatrix<number>::SparseMatrix (const SparsityPattern &c)
   val(nullptr),
   max_len(0)
 {
+  // virtual functions called in constructors and destructors never use the
+  // override in a derived class
+  // for clarity be explicit on which function is called
   SparseMatrix<number>::reinit (c);
 }
 
@@ -143,6 +146,9 @@ 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()));
 
+  // virtual functions called in constructors and destructors never use the
+  // override in a derived class
+  // for clarity be explicit on which function is called
   SparseMatrix<number>::reinit (c);
   for (size_type i=0; i<n(); ++i)
     this->set(i,i,1.);
index 3aaa7cc0c54c901b9a4cdd4bac791f4b3bb45544..c79dc761551ce72fbbcce03334604ed7850edf87 100644 (file)
@@ -36,6 +36,9 @@ SparseMIC<number>::SparseMIC ()
 template <typename number>
 SparseMIC<number>::~SparseMIC()
 {
+  // virtual functions called in constructors and destructors never use the
+  // override in a derived class
+  // for clarity be explicit on which function is called
   SparseMIC<number>::clear();
 }
 
index 410f72ce7406a2378236d8ba92357e365ed0334d..59ba4b2113dc13358a842529c3eff75025269c2f 100644 (file)
@@ -978,6 +978,9 @@ Vector<Number>::Vector ()
   max_vec_size(0),
   values(nullptr, &free)
 {
+  // virtual functions called in constructors and destructors never use the
+  // override in a derived class
+  // for clarity be explicit on which function is called
   Vector<Number>::reinit(0);
 }
 
@@ -1007,6 +1010,9 @@ Vector<Number>::Vector (const size_type n)
   max_vec_size(0),
   values(nullptr, &free)
 {
+  // virtual functions called in constructors and destructors never use the
+  // override in a derived class
+  // for clarity be explicit on which function is called
   Vector<Number>::reinit (n, false);
 }
 
index 1ce80a4c8a3a3161b8ba2ea6086b25ca679d0855..d766c4dcf126c257856fe2a3dc5976a45c798a82 100644 (file)
@@ -897,6 +897,9 @@ 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 ()
 {
+  // virtual functions called in constructors and destructors never use the
+  // override in a derived class
+  // for clarity be explicit on which function is called
   DataOut_DoFData<DoFHandlerType,patch_dim,patch_space_dim>::clear ();
 }
 
index a7c9f0e7dba78da24e6290a166764dc995e58ab3..ea0dc29f9f5f489bdeb839114b74d1b446b4ff23 100644 (file)
@@ -1304,6 +1304,9 @@ namespace parallel
     template <int dim, int spacedim>
     Triangulation<dim,spacedim>::~Triangulation ()
     {
+      // virtual functions called in constructors and destructors never use the
+      // override in a derived class
+      // for clarity be explicit on which function is called
       Triangulation<dim, spacedim>::clear ();
 
       Assert (triangulation_has_content == false,
index 459c28a666c1033be122223e6962da924e3a1377..72515d28c2d819a7524973a59deca656a1955372 100644 (file)
@@ -683,6 +683,9 @@ template <int dim, int spacedim>
 DoFHandler<dim,spacedim>::~DoFHandler ()
 {
   // release allocated memory
+  // virtual functions called in constructors and destructors never use the
+  // override in a derived class
+  // for clarity be explicit on which function is called
   DoFHandler<dim, spacedim>::clear ();
 
   // also release the policy. this needs to happen before the
index 9bf68c62cf454f0590e2f3c01688b39fdf4b47be..594299fdd5b9636ae96abdcb23bea055a1989f98 100644 (file)
@@ -1009,6 +1009,9 @@ namespace hp
     tria_listeners.clear ();
 
     // ...and release allocated memory
+    // virtual functions called in constructors and destructors never use the
+    // override in a derived class
+    // for clarity be explicit on which function is called
     DoFHandler<dim, spacedim>::clear ();
   }
 
index 81187f91b90cc2591e6ded252e50a7ebe48f9d7a..1bb64cecd3c6ac01f3d07f76f8fac47557cce9f0 100644 (file)
@@ -31,6 +31,9 @@ namespace PETScWrappers
     Vector::Vector ()
       : communicator (MPI_COMM_SELF)
     {
+      // virtual functions called in constructors and destructors never use the
+      // override in a derived class
+      // for clarity be explicit on which function is called
       Vector::create_vector(0, 0);
     }
 
index c652bfda915a0ec8a198cffeb605161f38782760..a23def7564181604c02cd51113d52b1f26c04c4f 100644 (file)
@@ -37,6 +37,9 @@ namespace LinearAlgebra
                                                const IndexSet &read_write_vector_index_set,
                                                const MPI_Comm &communicator)
     {
+      // virtual functions called in constructors and destructors never use the
+      // override in a derived class
+      // for clarity be explicit on which function is called
       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.