From: Daniel Arndt Date: Sat, 13 Jan 2018 13:53:04 +0000 (+0100) Subject: Be explicit about virtual functions called in constructors and destructors X-Git-Tag: v9.0.0-rc1~539^2~1 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=a87bdac58437f8e29f26e8d457167c05ae0f0f1a;p=dealii.git Be explicit about virtual functions called in constructors and destructors --- diff --git a/include/deal.II/base/time_stepping.templates.h b/include/deal.II/base/time_stepping.templates.h index c3f0cfd4bd..f2744ab35b 100644 --- a/include/deal.II/base/time_stepping.templates.h +++ b/include/deal.II/base/time_stepping.templates.h @@ -55,7 +55,7 @@ namespace TimeStepping template ExplicitRungeKutta::ExplicitRungeKutta(const runge_kutta_method method) { - initialize(method); + ExplicitRungeKutta::initialize(method); } @@ -211,7 +211,7 @@ namespace TimeStepping max_it(max_it), tolerance(tolerance) { - initialize(method); + ImplicitRungeKutta::initialize(method); } @@ -417,7 +417,7 @@ namespace TimeStepping last_same_as_first(false), last_stage(nullptr) { - initialize(method); + EmbeddedExplicitRungeKutta::initialize(method); } diff --git a/include/deal.II/lac/block_sparse_matrix.templates.h b/include/deal.II/lac/block_sparse_matrix.templates.h index 01bae4345f..8a0d2e6eaa 100644 --- a/include/deal.II/lac/block_sparse_matrix.templates.h +++ b/include/deal.II/lac/block_sparse_matrix.templates.h @@ -27,7 +27,7 @@ template BlockSparseMatrix:: BlockSparseMatrix (const BlockSparsityPattern &sparsity) { - reinit (sparsity); + BlockSparseMatrix::reinit (sparsity); } diff --git a/include/deal.II/lac/chunk_sparse_matrix.templates.h b/include/deal.II/lac/chunk_sparse_matrix.templates.h index 26d5e20a33..99d78af949 100644 --- a/include/deal.II/lac/chunk_sparse_matrix.templates.h +++ b/include/deal.II/lac/chunk_sparse_matrix.templates.h @@ -332,7 +332,7 @@ ChunkSparseMatrix::ChunkSparseMatrix (const ChunkSparsityPattern &c) val(nullptr), max_len(0) { - reinit (c); + ChunkSparseMatrix::reinit (c); } @@ -349,7 +349,7 @@ ChunkSparseMatrix::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::reinit (c); for (size_type i=0; iset(i,i,1.); } diff --git a/include/deal.II/lac/read_write_vector.h b/include/deal.II/lac/read_write_vector.h index 05c72f98ee..9b959c9920 100644 --- a/include/deal.II/lac/read_write_vector.h +++ b/include/deal.II/lac/read_write_vector.h @@ -673,7 +673,7 @@ namespace LinearAlgebra : val(nullptr) { - reinit(0, true); + ReadWriteVector::reinit(0, true); } @@ -696,7 +696,7 @@ namespace LinearAlgebra : val(nullptr) { - reinit (size, false); + ReadWriteVector::reinit (size, false); } @@ -707,7 +707,7 @@ namespace LinearAlgebra : val(nullptr) { - reinit (locally_stored_indices); + ReadWriteVector::reinit (locally_stored_indices); } diff --git a/include/deal.II/lac/sparse_decomposition.templates.h b/include/deal.II/lac/sparse_decomposition.templates.h index 027d97575e..d5d373302b 100644 --- a/include/deal.II/lac/sparse_decomposition.templates.h +++ b/include/deal.II/lac/sparse_decomposition.templates.h @@ -40,7 +40,7 @@ SparseLUDecomposition::SparseLUDecomposition() template SparseLUDecomposition::~SparseLUDecomposition() { - clear(); + SparseLUDecomposition::clear(); } diff --git a/include/deal.II/lac/sparse_matrix.templates.h b/include/deal.II/lac/sparse_matrix.templates.h index 53cfc44520..1fe0e27462 100644 --- a/include/deal.II/lac/sparse_matrix.templates.h +++ b/include/deal.II/lac/sparse_matrix.templates.h @@ -126,7 +126,7 @@ SparseMatrix::SparseMatrix (const SparsityPattern &c) val(nullptr), max_len(0) { - reinit (c); + SparseMatrix::reinit (c); } @@ -143,7 +143,7 @@ SparseMatrix::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::reinit (c); for (size_type i=0; iset(i,i,1.); } diff --git a/include/deal.II/lac/sparse_mic.templates.h b/include/deal.II/lac/sparse_mic.templates.h index c00e41f622..3aaa7cc0c5 100644 --- a/include/deal.II/lac/sparse_mic.templates.h +++ b/include/deal.II/lac/sparse_mic.templates.h @@ -36,7 +36,7 @@ SparseMIC::SparseMIC () template SparseMIC::~SparseMIC() { - clear(); + SparseMIC::clear(); } diff --git a/include/deal.II/lac/vector.h b/include/deal.II/lac/vector.h index 7e712c095b..410f72ce74 100644 --- a/include/deal.II/lac/vector.h +++ b/include/deal.II/lac/vector.h @@ -978,7 +978,7 @@ Vector::Vector () max_vec_size(0), values(nullptr, &free) { - reinit(0); + Vector::reinit(0); } @@ -1007,7 +1007,7 @@ Vector::Vector (const size_type n) max_vec_size(0), values(nullptr, &free) { - reinit (n, false); + Vector::reinit (n, false); } diff --git a/include/deal.II/numerics/data_out_dof_data.templates.h b/include/deal.II/numerics/data_out_dof_data.templates.h index 50f089419e..1ce80a4c8a 100644 --- a/include/deal.II/numerics/data_out_dof_data.templates.h +++ b/include/deal.II/numerics/data_out_dof_data.templates.h @@ -897,7 +897,7 @@ DataOut_DoFData::DataOut_DoFData () template DataOut_DoFData::~DataOut_DoFData () { - clear (); + DataOut_DoFData::clear (); } diff --git a/source/distributed/tria.cc b/source/distributed/tria.cc index 532ef24262..a7c9f0e7db 100644 --- a/source/distributed/tria.cc +++ b/source/distributed/tria.cc @@ -1304,7 +1304,7 @@ namespace parallel template Triangulation::~Triangulation () { - clear (); + Triangulation::clear (); Assert (triangulation_has_content == false, ExcInternalError()); diff --git a/source/dofs/dof_handler.cc b/source/dofs/dof_handler.cc index deb6abb60e..459c28a666 100644 --- a/source/dofs/dof_handler.cc +++ b/source/dofs/dof_handler.cc @@ -683,7 +683,7 @@ template DoFHandler::~DoFHandler () { // release allocated memory - clear (); + DoFHandler::clear (); // also release the policy. this needs to happen before the // current object disappears because the policy objects diff --git a/source/hp/dof_handler.cc b/source/hp/dof_handler.cc index 12a486eea9..9bf68c62cf 100644 --- a/source/hp/dof_handler.cc +++ b/source/hp/dof_handler.cc @@ -1009,7 +1009,7 @@ namespace hp tria_listeners.clear (); // ...and release allocated memory - clear (); + DoFHandler::clear (); } diff --git a/source/lac/petsc_parallel_vector.cc b/source/lac/petsc_parallel_vector.cc index d9911e9c24..81187f91b9 100644 --- a/source/lac/petsc_parallel_vector.cc +++ b/source/lac/petsc_parallel_vector.cc @@ -31,7 +31,7 @@ namespace PETScWrappers Vector::Vector () : communicator (MPI_COMM_SELF) { - create_vector(0, 0); + Vector::create_vector(0, 0); } diff --git a/source/lac/trilinos_epetra_communication_pattern.cc b/source/lac/trilinos_epetra_communication_pattern.cc index 63ca267c2f..c652bfda91 100644 --- a/source/lac/trilinos_epetra_communication_pattern.cc +++ b/source/lac/trilinos_epetra_communication_pattern.cc @@ -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); }