From 13990dbc529aee3434f406e7227b457bfad2ccd6 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Fri, 11 Oct 2024 15:14:47 -0600 Subject: [PATCH] Rename the class to EnableObserverPointer. --- doc/doxygen/headers/coding_conventions.h | 2 +- doc/doxygen/headers/memory.h | 2 +- examples/step-14/step-14.cc | 6 +- examples/step-21/step-21.cc | 6 +- examples/step-22/doc/results.dox | 2 +- examples/step-22/step-22.cc | 4 +- examples/step-29/step-29.cc | 2 +- examples/step-31/step-31.cc | 4 +- examples/step-32/step-32.cc | 2 +- examples/step-37/step-37.cc | 2 +- examples/step-39/step-39.cc | 2 +- examples/step-43/step-43.cc | 4 +- examples/step-45/step-45.cc | 2 +- examples/step-55/step-55.cc | 5 +- examples/step-56/step-56.cc | 2 +- examples/step-57/step-57.cc | 2 +- examples/step-59/step-59.cc | 4 +- examples/step-64/step-64.cc | 2 +- examples/step-66/step-66.cc | 2 +- examples/step-7/step-7.cc | 8 +-- examples/step-75/step-75.cc | 2 +- examples/step-83/doc/intro.dox | 4 +- include/deal.II/algorithms/any_data.h | 2 +- .../deal.II/algorithms/general_data_storage.h | 2 +- include/deal.II/algorithms/operator.h | 4 +- include/deal.II/algorithms/timestep_control.h | 2 +- .../enable_ref_counting_by_observer_pointer.h | 53 ++++++++--------- include/deal.II/base/function.h | 2 +- include/deal.II/base/logstream.h | 2 +- include/deal.II/base/mg_level_object.h | 2 +- include/deal.II/base/observer_pointer.h | 57 ++++++++----------- include/deal.II/base/parameter_acceptor.h | 2 +- include/deal.II/base/parameter_handler.h | 6 +- include/deal.II/base/polynomial.h | 4 +- include/deal.II/base/polynomials_piecewise.h | 4 +- include/deal.II/base/quadrature.h | 4 +- include/deal.II/base/quadrature_point_data.h | 2 +- include/deal.II/base/table.h | 12 ++-- include/deal.II/base/tensor_function.h | 2 +- .../distributed/repartitioning_policy_tools.h | 2 +- include/deal.II/distributed/shared_tria.h | 3 +- include/deal.II/distributed/tria.h | 3 +- include/deal.II/dofs/block_info.h | 2 +- include/deal.II/dofs/dof_handler.h | 2 +- include/deal.II/fe/fe.h | 2 +- include/deal.II/fe/fe_series.h | 4 +- include/deal.II/fe/fe_tools.h | 2 +- include/deal.II/fe/fe_tools.templates.h | 35 +++++------- include/deal.II/fe/fe_values_base.h | 2 +- include/deal.II/fe/mapping.h | 2 +- include/deal.II/grid/grid_tools_cache.h | 2 +- include/deal.II/grid/intergrid_map.h | 2 +- include/deal.II/grid/manifold.h | 2 +- include/deal.II/grid/tria.h | 2 +- include/deal.II/hp/collection.h | 2 +- include/deal.II/hp/fe_values.h | 2 +- include/deal.II/lac/affine_constraints.h | 4 +- include/deal.II/lac/arpack_solver.h | 2 +- include/deal.II/lac/block_indices.h | 2 +- include/deal.II/lac/block_matrix_base.h | 2 +- include/deal.II/lac/block_sparse_matrix_ez.h | 2 +- .../lac/block_sparse_matrix_ez.templates.h | 2 +- include/deal.II/lac/block_vector_base.h | 2 +- include/deal.II/lac/chunk_sparse_matrix.h | 2 +- .../lac/chunk_sparse_matrix.templates.h | 2 +- include/deal.II/lac/chunk_sparsity_pattern.h | 2 +- include/deal.II/lac/diagonal_matrix.h | 2 +- include/deal.II/lac/la_parallel_vector.h | 2 +- .../lac/la_parallel_vector.templates.h | 10 ++-- include/deal.II/lac/lapack_full_matrix.h | 2 +- include/deal.II/lac/matrix_block.h | 4 +- include/deal.II/lac/parpack_solver.h | 2 +- include/deal.II/lac/petsc_matrix_base.h | 2 +- include/deal.II/lac/petsc_precondition.h | 2 +- include/deal.II/lac/petsc_snes.h | 4 +- include/deal.II/lac/petsc_ts.h | 4 +- include/deal.II/lac/petsc_vector_base.h | 6 +- include/deal.II/lac/precondition.h | 12 ++-- include/deal.II/lac/precondition_block.h | 8 +-- include/deal.II/lac/precondition_selector.h | 2 +- include/deal.II/lac/read_write_vector.h | 4 +- include/deal.II/lac/relaxation_block.h | 8 +-- include/deal.II/lac/solver.h | 2 +- include/deal.II/lac/solver_control.h | 2 +- include/deal.II/lac/solver_selector.h | 2 +- include/deal.II/lac/sparse_decomposition.h | 2 +- include/deal.II/lac/sparse_direct.h | 2 +- include/deal.II/lac/sparse_matrix.h | 2 +- include/deal.II/lac/sparse_matrix.templates.h | 4 +- include/deal.II/lac/sparse_matrix_ez.h | 2 +- .../deal.II/lac/sparse_matrix_ez.templates.h | 2 +- include/deal.II/lac/sparsity_pattern.h | 7 +-- include/deal.II/lac/sparsity_pattern_base.h | 2 +- include/deal.II/lac/trilinos_epetra_vector.h | 2 +- include/deal.II/lac/trilinos_precondition.h | 2 +- include/deal.II/lac/trilinos_solver.h | 2 +- include/deal.II/lac/trilinos_sparse_matrix.h | 2 +- .../lac/trilinos_tpetra_precondition.h | 2 +- .../lac/trilinos_tpetra_sparse_matrix.h | 2 +- include/deal.II/lac/trilinos_tpetra_vector.h | 3 +- .../lac/trilinos_tpetra_vector.templates.h | 10 ++-- include/deal.II/lac/trilinos_vector.h | 2 +- include/deal.II/lac/vector.h | 7 +-- include/deal.II/lac/vector.templates.h | 2 +- include/deal.II/lac/vector_memory.h | 2 +- .../matrix_free/fe_remote_evaluation.h | 2 +- include/deal.II/matrix_free/matrix_free.h | 2 +- .../matrix_free/matrix_free.templates.h | 4 +- include/deal.II/matrix_free/operators.h | 8 +-- .../matrix_free/portable_matrix_free.h | 2 +- include/deal.II/meshworker/local_integrator.h | 3 +- include/deal.II/meshworker/vector_selector.h | 2 +- include/deal.II/multigrid/mg_base.h | 8 +-- .../deal.II/multigrid/mg_constrained_dofs.h | 2 +- .../multigrid/mg_transfer_global_coarsening.h | 2 +- include/deal.II/multigrid/multigrid.h | 4 +- .../multigrid/sparse_matrix_collection.h | 2 +- include/deal.II/non_matching/mapping_info.h | 2 +- .../deal.II/non_matching/mesh_classifier.h | 2 +- include/deal.II/numerics/data_postprocessor.h | 2 +- include/deal.II/numerics/time_dependent.h | 2 +- include/deal.II/particles/particle_handler.h | 2 +- .../base/enable_ref_counting_by_observer.cc | 28 +++++---- source/base/quadrature.cc | 8 +-- source/grid/tria.cc | 4 +- source/hp/fe_values.cc | 2 +- source/lac/chunk_sparsity_pattern.cc | 2 +- source/lac/petsc_vector_base.cc | 4 +- source/lac/trilinos_epetra_vector.cc | 6 +- source/lac/trilinos_vector.cc | 10 ++-- tests/algorithms/newton_01.cc | 2 +- tests/base/assign_subscriptor.cc | 38 ++++++------- tests/base/reference.cc | 2 +- tests/base/smart_pointer_01.cc | 2 +- tests/base/smart_pointer_02.cc | 2 +- tests/base/unsubscribe_subscriptor.cc | 10 ++-- .../base/unsubscribe_subscriptor.debug.output | 14 ++--- ...subscribe_subscriptor.debug.output.clang-6 | 14 ++--- ...nsubscribe_subscriptor.debug.output.gcc-12 | 14 ++--- ...unsubscribe_subscriptor.debug.output.intel | 14 ++--- tests/base/unsubscribe_subscriptor_01.cc | 10 ++-- tests/bits/joa_1.cc | 2 +- tests/bits/sparse_lu_decomposition_1.cc | 2 +- tests/bits/step-14.cc | 4 +- tests/fe/fe_q_dg0.cc | 4 +- tests/hp/crash_21.cc | 2 +- tests/integrators/cells_and_faces_01.cc | 2 +- tests/integrators/functional_01.cc | 2 +- tests/integrators/mesh_worker_01.cc | 2 +- tests/integrators/mesh_worker_02.cc | 2 +- tests/integrators/mesh_worker_03.cc | 2 +- tests/integrators/mesh_worker_matrix_01.cc | 2 +- tests/lac/precondition_chebyshev_07.cc | 2 +- tests/lac/precondition_relaxation_01.cc | 2 +- tests/matrix_free/compare_faces_by_cells.cc | 2 +- tests/matrix_free/multigrid_dg_periodic.cc | 2 +- tests/matrix_free/multigrid_dg_sip_01.cc | 2 +- tests/matrix_free/multigrid_dg_sip_02.cc | 2 +- tests/matrix_free/parallel_multigrid.cc | 2 +- .../parallel_multigrid_adaptive_01.cc | 4 +- .../parallel_multigrid_adaptive_03.cc | 4 +- .../parallel_multigrid_adaptive_05.cc | 4 +- .../parallel_multigrid_adaptive_06.cc | 4 +- .../parallel_multigrid_adaptive_07.cc | 4 +- .../parallel_multigrid_fullydistributed.cc | 2 +- .../parallel_multigrid_interleave.cc | 2 +- .../parallel_multigrid_interleave_renumber.cc | 2 +- tests/matrix_free/parallel_multigrid_mf.cc | 2 +- tests/matrix_free/solver_cg_interleave.cc | 2 +- tests/matrix_free/step-37.cc | 4 +- tests/matrix_free/stokes_computation.cc | 2 +- .../coefficient_eval_device.cc | 2 +- .../matrix_vector_device_mf.h | 2 +- tests/mpi/mesh_worker_matrix_01.cc | 2 +- .../multigrid_dg_periodic.cc | 2 +- .../multigrid_dg_sip_01.cc | 2 +- .../multigrid_dg_sip_02.cc | 2 +- .../multigrid_util.h | 2 +- .../parallel_multigrid.cc | 2 +- .../parallel_multigrid_adaptive_01.cc | 4 +- .../parallel_multigrid_adaptive_03.cc | 4 +- .../parallel_multigrid_adaptive_05.cc | 4 +- .../parallel_multigrid_adaptive_06.cc | 4 +- .../parallel_multigrid_adaptive_07.cc | 4 +- .../parallel_multigrid_fullydistributed.cc | 2 +- .../parallel_multigrid_interleave.cc | 2 +- .../parallel_multigrid_interleave_renumber.cc | 2 +- .../parallel_multigrid_mf.cc | 2 +- .../stokes_computation.cc | 2 +- tests/multigrid/mg_renumbered_02.cc | 2 +- tests/multigrid/mg_renumbered_03.cc | 2 +- tests/numerics/no_flux_18.cc | 2 +- tests/performance/instrumentation_step_22.cc | 4 +- tests/performance/timing_mg_glob_coarsen.cc | 2 +- tests/performance/timing_step_22.cc | 4 +- tests/petsc/petsc_snes_02.cc | 4 +- tests/petsc/petsc_ts_01.cc | 4 +- tests/simplex/step-31.cc | 4 +- tests/simplex/step-55.cc | 5 +- tests/simplex/stokes-sv.cc | 2 +- 200 files changed, 413 insertions(+), 448 deletions(-) diff --git a/doc/doxygen/headers/coding_conventions.h b/doc/doxygen/headers/coding_conventions.h index d227f02117..7194277f94 100644 --- a/doc/doxygen/headers/coding_conventions.h +++ b/doc/doxygen/headers/coding_conventions.h @@ -211,7 +211,7 @@ functions with their own user-defined types by including the .templates.h files.
  • Finally, if we can not assume in advance which values template arguments -will take (e.g., any class derived from EnableRefCountingByObserverPointer can be used as an argument), +will take (e.g., any class derived from EnableObserverPointer can be used as an argument), the definitions of functions are provided at the bottom of the header file with declarations. The definitions should be guarded with \#ifndef DOXYGEN ... \#endif to prevent Doxygen from picking them up.
  • diff --git a/doc/doxygen/headers/memory.h b/doc/doxygen/headers/memory.h index fd833ff8c6..7e94df1e60 100644 --- a/doc/doxygen/headers/memory.h +++ b/doc/doxygen/headers/memory.h @@ -17,7 +17,7 @@ * @defgroup memory Memory handling * * This group has some basic classes and namespaces for memory - * handling. The EnableRefCountingByObserverPointer and ObserverPointer classes are used for + * handling. The EnableObserverPointer and ObserverPointer classes are used for * counted memory handling, i.e. whenever a ObserverPointer is set to * point to an object, it increases a counter in that object; when the * pointer is set to point elsewhere, it decreases it again. This way, diff --git a/examples/step-14/step-14.cc b/examples/step-14/step-14.cc index 9afa6e3c1c..4496a2bac9 100644 --- a/examples/step-14/step-14.cc +++ b/examples/step-14/step-14.cc @@ -1053,9 +1053,9 @@ namespace Step14 // Based on the above description, the SetUpBase class then // looks as follows. To allow using the ObserverPointer class // with this class, we derived from the - // EnableRefCountingByObserverPointer class. + // EnableObserverPointer class. template - struct SetUpBase : public EnableRefCountingByObserverPointer + struct SetUpBase : public EnableObserverPointer { virtual const Function &get_boundary_values() const = 0; @@ -1384,7 +1384,7 @@ namespace Step14 // the right hand side, we only need to provide for a function that // assembles the right hand side for a given discretization: template - class DualFunctionalBase : public EnableRefCountingByObserverPointer + class DualFunctionalBase : public EnableObserverPointer { public: virtual void assemble_rhs(const DoFHandler &dof_handler, diff --git a/examples/step-21/step-21.cc b/examples/step-21/step-21.cc index 97719ad2e0..6dfcb06fb7 100644 --- a/examples/step-21/step-21.cc +++ b/examples/step-21/step-21.cc @@ -409,7 +409,7 @@ namespace Step21 // maximum number of iterations equal to the maximum of the size of the linear // system and 200. template - class InverseMatrix : public EnableRefCountingByObserverPointer + class InverseMatrix : public EnableObserverPointer { public: InverseMatrix(const MatrixType &m) @@ -433,7 +433,7 @@ namespace Step21 - class SchurComplement : public EnableRefCountingByObserverPointer + class SchurComplement : public EnableObserverPointer { public: SchurComplement(const BlockSparseMatrix &A, @@ -460,7 +460,7 @@ namespace Step21 - class ApproximateSchurComplement : public EnableRefCountingByObserverPointer + class ApproximateSchurComplement : public EnableObserverPointer { public: ApproximateSchurComplement(const BlockSparseMatrix &A) diff --git a/examples/step-22/doc/results.dox b/examples/step-22/doc/results.dox index 0323ad696c..f50903afa7 100644 --- a/examples/step-22/doc/results.dox +++ b/examples/step-22/doc/results.dox @@ -407,7 +407,7 @@ according to the derivation above can be specified by three successive operations: @code template -class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer +class BlockSchurPreconditioner : public EnableObserverPointer { public: BlockSchurPreconditioner (const BlockSparseMatrix &S, diff --git a/examples/step-22/step-22.cc b/examples/step-22/step-22.cc index 4c78dbc887..7f9cf5de7a 100644 --- a/examples/step-22/step-22.cc +++ b/examples/step-22/step-22.cc @@ -279,7 +279,7 @@ namespace Step22 // InverseMatrix object is created. The member function // vmult is obtained by solving a linear system: template - class InverseMatrix : public EnableRefCountingByObserverPointer + class InverseMatrix : public EnableObserverPointer { public: InverseMatrix(const MatrixType &m, @@ -337,7 +337,7 @@ namespace Step22 // a preconditioner class as above, which affects the // ObserverPointer object m_inverse as well. template - class SchurComplement : public EnableRefCountingByObserverPointer + class SchurComplement : public EnableObserverPointer { public: SchurComplement( diff --git a/examples/step-29/step-29.cc b/examples/step-29/step-29.cc index 89ed4ec590..d079904cdc 100644 --- a/examples/step-29/step-29.cc +++ b/examples/step-29/step-29.cc @@ -123,7 +123,7 @@ namespace Step29 // declare_parameters that declares all the necessary // parameters and a read_parameters function that is called // from outside to initiate the parameter reading process. - class ParameterReader : public EnableRefCountingByObserverPointer + class ParameterReader : public EnableObserverPointer { public: ParameterReader(ParameterHandler &); diff --git a/examples/step-31/step-31.cc b/examples/step-31/step-31.cc index 76411eaf62..9f7b708e7b 100644 --- a/examples/step-31/step-31.cc +++ b/examples/step-31/step-31.cc @@ -242,7 +242,7 @@ namespace Step31 // we can abort the program preserving information about where the // problem happened. template - class InverseMatrix : public EnableRefCountingByObserverPointer + class InverseMatrix : public EnableObserverPointer { public: InverseMatrix(const MatrixType &m, @@ -342,7 +342,7 @@ namespace Step31 // preconditioners in the constructor and that the matrices we use here // are built upon Trilinos: template - class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer + class BlockSchurPreconditioner : public EnableObserverPointer { public: BlockSchurPreconditioner( diff --git a/examples/step-32/step-32.cc b/examples/step-32/step-32.cc index 81c8897727..ec940a28fe 100644 --- a/examples/step-32/step-32.cc +++ b/examples/step-32/step-32.cc @@ -224,7 +224,7 @@ namespace Step32 namespace LinearSolvers { template - class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer + class BlockSchurPreconditioner : public EnableObserverPointer { public: BlockSchurPreconditioner(const TrilinosWrappers::BlockSparseMatrix &S, diff --git a/examples/step-37/step-37.cc b/examples/step-37/step-37.cc index b109dc2255..f6c09edd7c 100644 --- a/examples/step-37/step-37.cc +++ b/examples/step-37/step-37.cc @@ -246,7 +246,7 @@ namespace Step37 // This is the constructor of the @p LaplaceOperator class. All it does is // to call the default constructor of the base class // MatrixFreeOperators::Base, which in turn is based on the - // EnableRefCountingByObserverPointer class that asserts that this class is + // EnableObserverPointer class that asserts that this class is // not accessed after going out of scope e.g. in a preconditioner. template LaplaceOperator::LaplaceOperator() diff --git a/examples/step-39/step-39.cc b/examples/step-39/step-39.cc index a1d5e29b0f..f4b1541eec 100644 --- a/examples/step-39/step-39.cc +++ b/examples/step-39/step-39.cc @@ -621,7 +621,7 @@ namespace Step39 // It is important to update the sparsity patterns after clear() // was called for the level matrices, since the matrices lock the sparsity // pattern through the ObserverPointer and - // EnableRefCountingByObserverPointer mechanism. + // EnableObserverPointer mechanism. mg_sparsity.resize(0, n_levels - 1); mg_sparsity_dg_interface.resize(0, n_levels - 1); diff --git a/examples/step-43/step-43.cc b/examples/step-43/step-43.cc index 76f807ff6f..e3babd3dc3 100644 --- a/examples/step-43/step-43.cc +++ b/examples/step-43/step-43.cc @@ -318,7 +318,7 @@ namespace Step43 namespace LinearSolvers { template - class InverseMatrix : public EnableRefCountingByObserverPointer + class InverseMatrix : public EnableObserverPointer { public: InverseMatrix(const MatrixType &m, @@ -366,7 +366,7 @@ namespace Step43 } template - class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer + class BlockSchurPreconditioner : public EnableObserverPointer { public: BlockSchurPreconditioner( diff --git a/examples/step-45/step-45.cc b/examples/step-45/step-45.cc index 5d1f56db0e..6b330b1a69 100644 --- a/examples/step-45/step-45.cc +++ b/examples/step-45/step-45.cc @@ -185,7 +185,7 @@ namespace Step45 template - class InverseMatrix : public EnableRefCountingByObserverPointer + class InverseMatrix : public EnableObserverPointer { public: InverseMatrix(const MatrixType &m, diff --git a/examples/step-55/step-55.cc b/examples/step-55/step-55.cc index 8577068aa8..2f64d3c7e9 100644 --- a/examples/step-55/step-55.cc +++ b/examples/step-55/step-55.cc @@ -97,7 +97,7 @@ namespace Step55 // step-31 to convert a run-time exception into a failed assertion // should the inner solver not converge. template - class InverseMatrix : public EnableRefCountingByObserverPointer + class InverseMatrix : public EnableObserverPointer { public: InverseMatrix(const Matrix &m, const Preconditioner &preconditioner); @@ -145,8 +145,7 @@ namespace Step55 // The class A template class for a simple block diagonal preconditioner // for 2x2 matrices. template - class BlockDiagonalPreconditioner - : public EnableRefCountingByObserverPointer + class BlockDiagonalPreconditioner : public EnableObserverPointer { public: BlockDiagonalPreconditioner(const PreconditionerA &preconditioner_A, diff --git a/examples/step-56/step-56.cc b/examples/step-56/step-56.cc index a047f5e1d4..53a4fa2fd7 100644 --- a/examples/step-56/step-56.cc +++ b/examples/step-56/step-56.cc @@ -301,7 +301,7 @@ namespace Step56 // Notice how we keep track of the sum of the inner iterations // (preconditioner applications). template - class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer + class BlockSchurPreconditioner : public EnableObserverPointer { public: BlockSchurPreconditioner( diff --git a/examples/step-57/step-57.cc b/examples/step-57/step-57.cc index 2a779e0aa4..f4de39e52d 100644 --- a/examples/step-57/step-57.cc +++ b/examples/step-57/step-57.cc @@ -182,7 +182,7 @@ namespace Step57 // positive definite, we can use CG to solve the corresponding linear // system. template - class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer + class BlockSchurPreconditioner : public EnableObserverPointer { public: BlockSchurPreconditioner(double gamma, diff --git a/examples/step-59/step-59.cc b/examples/step-59/step-59.cc index f0490e671a..9755df42e1 100644 --- a/examples/step-59/step-59.cc +++ b/examples/step-59/step-59.cc @@ -147,7 +147,7 @@ namespace Step59 // MatrixFreeOperators::Base because we want to present some additional // features of MatrixFree::loop() that are not available in the // general-purpose class MatrixFreeOperators::Base. We derive the class from - // the EnableRefCountingByObserverPointer class to be able to use the operator + // the EnableObserverPointer class to be able to use the operator // within the Chebyshev preconditioner because that preconditioner stores the // underlying matrix via a ObserverPointer. // @@ -160,7 +160,7 @@ namespace Step59 // step-39. template - class LaplaceOperator : public EnableRefCountingByObserverPointer + class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; diff --git a/examples/step-64/step-64.cc b/examples/step-64/step-64.cc index 8a7004b056..276604aa2e 100644 --- a/examples/step-64/step-64.cc +++ b/examples/step-64/step-64.cc @@ -246,7 +246,7 @@ namespace Step64 // needs to have a `vmult()` function that performs the action of // the linear operator on a source vector. template - class HelmholtzOperator : public EnableRefCountingByObserverPointer + class HelmholtzOperator : public EnableObserverPointer { public: HelmholtzOperator(const DoFHandler &dof_handler, diff --git a/examples/step-66/step-66.cc b/examples/step-66/step-66.cc index 23b47e5628..255deb6342 100644 --- a/examples/step-66/step-66.cc +++ b/examples/step-66/step-66.cc @@ -151,7 +151,7 @@ namespace Step66 // The constructor of the JacobianOperator just calls the // constructor of the base class MatrixFreeOperators::Base, which is itself - // derived from the EnableRefCountingByObserverPointer class. + // derived from the EnableObserverPointer class. template JacobianOperator::JacobianOperator() : MatrixFreeOperators::Base - class LaplaceOperator : public EnableRefCountingByObserverPointer + class LaplaceOperator : public EnableObserverPointer { public: using VectorType = LinearAlgebra::distributed::Vector; diff --git a/examples/step-83/doc/intro.dox b/examples/step-83/doc/intro.dox index e2a5be2fdd..a38b58adc1 100644 --- a/examples/step-83/doc/intro.dox +++ b/examples/step-83/doc/intro.dox @@ -190,7 +190,7 @@ writes into the `values` member variable. If the class had more member variables, one would list them one after the other. The same is true if a class has base classes. For example, here is the corresponding function for the Quadrature class that stores quadrature points and -weights, and is derived from the EnableRefCountingByObserverPointer base class: +weights, and is derived from the EnableObserverPointer base class: @code template template @@ -198,7 +198,7 @@ inline void Quadrature::serialize(Archive &ar, const unsigned int) { // Forward to the (de)serialization function in the base class: - ar & static_cast(*this); + ar & static_cast(*this); // Then (de)serialize the member variables: ar & quadrature_points & weights; diff --git a/include/deal.II/algorithms/any_data.h b/include/deal.II/algorithms/any_data.h index a6680df6d9..a3a03afe38 100644 --- a/include/deal.II/algorithms/any_data.h +++ b/include/deal.II/algorithms/any_data.h @@ -32,7 +32,7 @@ DEAL_II_NAMESPACE_OPEN * * @todo GK: Deprecate access to AnyData by index and change to a map. */ -class AnyData : public EnableRefCountingByObserverPointer +class AnyData : public EnableObserverPointer { public: /// Default constructor for empty object diff --git a/include/deal.II/algorithms/general_data_storage.h b/include/deal.II/algorithms/general_data_storage.h index 8cfda5419e..da3fd8d2ee 100644 --- a/include/deal.II/algorithms/general_data_storage.h +++ b/include/deal.II/algorithms/general_data_storage.h @@ -38,7 +38,7 @@ DEAL_II_NAMESPACE_OPEN * * When using this class, please cite @cite SartoriGiulianiBardelloni-2018-a. */ -class GeneralDataStorage : public EnableRefCountingByObserverPointer +class GeneralDataStorage : public EnableObserverPointer { public: /** diff --git a/include/deal.II/algorithms/operator.h b/include/deal.II/algorithms/operator.h index ec2779fa80..9d77ed1638 100644 --- a/include/deal.II/algorithms/operator.h +++ b/include/deal.II/algorithms/operator.h @@ -62,7 +62,7 @@ namespace Algorithms * providing additional information and forwarded to the inner Operator * objects of the nested iteration. */ - class OperatorBase : public EnableRefCountingByObserverPointer + class OperatorBase : public EnableObserverPointer { public: /** @@ -101,7 +101,7 @@ namespace Algorithms * in each step of an iteration. */ template - class OutputOperator : public EnableRefCountingByObserverPointer + class OutputOperator : public EnableObserverPointer { public: /** diff --git a/include/deal.II/algorithms/timestep_control.h b/include/deal.II/algorithms/timestep_control.h index 2021095e3c..676e26c9c8 100644 --- a/include/deal.II/algorithms/timestep_control.h +++ b/include/deal.II/algorithms/timestep_control.h @@ -57,7 +57,7 @@ namespace Algorithms * with a more modern interface and better programming guarantees. Consider * using DiscreteTime instead of TimestepControl. */ - class TimestepControl : public EnableRefCountingByObserverPointer + class TimestepControl : public EnableObserverPointer { public: /** diff --git a/include/deal.II/base/enable_ref_counting_by_observer_pointer.h b/include/deal.II/base/enable_ref_counting_by_observer_pointer.h index 35eeeab758..32e250f757 100644 --- a/include/deal.II/base/enable_ref_counting_by_observer_pointer.h +++ b/include/deal.II/base/enable_ref_counting_by_observer_pointer.h @@ -34,7 +34,7 @@ DEAL_II_NAMESPACE_OPEN * * This class, as a base class, allows to keep track of other objects using a * specific object. It is used to avoid that pointers that point to an object of - * a class derived from EnableRefCountingByObserverPointer are referenced after + * a class derived from EnableObserverPointer are referenced after * that object has been invalidated. Here, invalidation is assumed to happen * when the object is moved from or destroyed. The mechanism works as follows: * The member function subscribe() accepts a pointer to a boolean that is @@ -56,13 +56,13 @@ DEAL_II_NAMESPACE_OPEN * * @ingroup memory */ -class EnableRefCountingByObserverPointer +class EnableObserverPointer { public: /** * Constructor setting the counter to zero. */ - EnableRefCountingByObserverPointer(); + EnableObserverPointer(); /** * Copy-constructor. @@ -70,22 +70,20 @@ public: * The counter of the copy is zero, since references point to the original * object. */ - EnableRefCountingByObserverPointer( - const EnableRefCountingByObserverPointer &); + EnableObserverPointer(const EnableObserverPointer &); /** * Move constructor. * - * An object inheriting from EnableRefCountingByObserverPointer can only be + * An object inheriting from EnableObserverPointer can only be * moved if no other objects are subscribing to it. */ - EnableRefCountingByObserverPointer( - EnableRefCountingByObserverPointer &&) noexcept; + EnableObserverPointer(EnableObserverPointer &&) noexcept; /** * Destructor, asserting that the counter is zero. */ - virtual ~EnableRefCountingByObserverPointer(); + virtual ~EnableObserverPointer(); /** * Assignment operator. @@ -93,19 +91,19 @@ public: * This has to be handled with care, too, because the counter has to remain * the same. It therefore does nothing more than returning *this. */ - EnableRefCountingByObserverPointer & - operator=(const EnableRefCountingByObserverPointer &); + EnableObserverPointer & + operator=(const EnableObserverPointer &); /** * Move assignment operator. Only invalidates the object moved from. */ - EnableRefCountingByObserverPointer & - operator=(EnableRefCountingByObserverPointer &&) noexcept; + EnableObserverPointer & + operator=(EnableObserverPointer &&) noexcept; /** - * @name EnableRefCountingByObserverPointer functionality + * @name EnableObserverPointer functionality * - * Classes derived from EnableRefCountingByObserverPointer provide a facility + * Classes derived from EnableObserverPointer provide a facility * to subscribe to this object. This is mostly used by the ObserverPointer * class. * @{ @@ -175,7 +173,7 @@ public: /** * A subscriber with the identification string given to - * EnableRefCountingByObserverPointer::unsubscribe() did not subscribe to the + * EnableObserverPointer::unsubscribe() did not subscribe to the * object. */ DeclException2(ExcNoSubscriber, @@ -277,36 +275,35 @@ private: /** - * A type alias for the EnableRefCountingByObserverPointer class that makes sure + * A type alias for the EnableObserverPointer class that makes sure * the previous name of the class, Subscriptor, continues to be available. * * @deprecated Use the new name of the class, ObserverPointer, instead. */ using Subscriptor DEAL_II_DEPRECATED_EARLY_WITH_COMMENT( - "Use the new name of the class, EnableRefCountingByObserverPointer.") = - EnableRefCountingByObserverPointer; + "Use the new name of the class, EnableObserverPointer.") = + EnableObserverPointer; //--------------------------------------------------------------------------- -inline EnableRefCountingByObserverPointer::EnableRefCountingByObserverPointer() +inline EnableObserverPointer::EnableObserverPointer() : counter(0) , object_info(nullptr) {} -inline EnableRefCountingByObserverPointer::EnableRefCountingByObserverPointer( - const EnableRefCountingByObserverPointer &) +inline EnableObserverPointer::EnableObserverPointer( + const EnableObserverPointer &) : counter(0) , object_info(nullptr) {} -inline EnableRefCountingByObserverPointer & -EnableRefCountingByObserverPointer::operator=( - const EnableRefCountingByObserverPointer &s) +inline EnableObserverPointer & +EnableObserverPointer::operator=(const EnableObserverPointer &s) { object_info = s.object_info; return *this; @@ -315,7 +312,7 @@ EnableRefCountingByObserverPointer::operator=( inline unsigned int -EnableRefCountingByObserverPointer::n_subscriptions() const +EnableObserverPointer::n_subscriptions() const { return counter; } @@ -324,7 +321,7 @@ EnableRefCountingByObserverPointer::n_subscriptions() const template inline void -EnableRefCountingByObserverPointer::serialize(Archive &, const unsigned int) +EnableObserverPointer::serialize(Archive &, const unsigned int) { // do nothing, as explained in the // documentation of this function @@ -332,7 +329,7 @@ EnableRefCountingByObserverPointer::serialize(Archive &, const unsigned int) template inline void -EnableRefCountingByObserverPointer::list_subscribers(StreamType &stream) const +EnableObserverPointer::list_subscribers(StreamType &stream) const { std::lock_guard lock(mutex); diff --git a/include/deal.II/base/function.h b/include/deal.II/base/function.h index 5cafbaa951..d760a90cad 100644 --- a/include/deal.II/base/function.h +++ b/include/deal.II/base/function.h @@ -148,7 +148,7 @@ class TensorFunction; template class Function : public FunctionTime< typename numbers::NumberTraits::real_type>, - public EnableRefCountingByObserverPointer + public EnableObserverPointer { public: /** diff --git a/include/deal.II/base/logstream.h b/include/deal.II/base/logstream.h index b80dae2822..68f02aa3bd 100644 --- a/include/deal.II/base/logstream.h +++ b/include/deal.II/base/logstream.h @@ -77,7 +77,7 @@ DEAL_II_NAMESPACE_OPEN * * @ingroup textoutput */ -class LogStream : public EnableRefCountingByObserverPointer +class LogStream : public EnableObserverPointer { public: /** diff --git a/include/deal.II/base/mg_level_object.h b/include/deal.II/base/mg_level_object.h index 6a76af25e7..ff11c5e9ec 100644 --- a/include/deal.II/base/mg_level_object.h +++ b/include/deal.II/base/mg_level_object.h @@ -45,7 +45,7 @@ DEAL_II_NAMESPACE_OPEN * @ingroup data */ template -class MGLevelObject : public EnableRefCountingByObserverPointer +class MGLevelObject : public EnableObserverPointer { public: /** diff --git a/include/deal.II/base/observer_pointer.h b/include/deal.II/base/observer_pointer.h index 4ed8c8fa73..2ea771aedc 100644 --- a/include/deal.II/base/observer_pointer.h +++ b/include/deal.II/base/observer_pointer.h @@ -46,7 +46,7 @@ DEAL_II_NAMESPACE_OPEN * deleted or moved from in the course of use of the pointer by signaling the * pointee its use. This is achieved by keeping a use count for the pointed-to * object (which for this purpose needs to be derived from the - * EnableRefCountingByObserverPointer class), and ensuring that the pointed-to + * EnableObserverPointer class), and ensuring that the pointed-to * object's destructor triggers an error if that use-count is larger than zero * -- i.e., if there are still observing ObserverPointer objects pointing to it. * @@ -96,7 +96,7 @@ DEAL_II_NAMESPACE_OPEN * to a constant object (disallowing write access when dereferenced), while * `ObserverPointer` is a mutable pointer. * - * @dealiiConceptRequires{std::is_base_of_v} * * @ingroup memory @@ -135,8 +135,8 @@ public: * lock it, i.e. to prevent its destruction before the end of its use. * * The id is used in the call to - * EnableRefCountingByObserverPointer::subscribe(id) and by ~ObserverPointer() - * in the call to EnableRefCountingByObserverPointer::unsubscribe(). + * EnableObserverPointer::subscribe(id) and by ~ObserverPointer() + * in the call to EnableObserverPointer::unsubscribe(). */ ObserverPointer(T *t, const std::string &id); @@ -283,10 +283,9 @@ inline ObserverPointer::ObserverPointer() , id(typeid(P).name()) , pointed_to_object_is_alive(false) { - static_assert( - std::is_base_of_v, - "This class can only be used if the first template argument " - "is a class derived from 'EnableRefCountingByObserverPointer'."); + static_assert(std::is_base_of_v, + "This class can only be used if the first template argument " + "is a class derived from 'EnableObserverPointer'."); } @@ -297,10 +296,9 @@ inline ObserverPointer::ObserverPointer(T *t) , id(typeid(P).name()) , pointed_to_object_is_alive(false) { - static_assert( - std::is_base_of_v, - "This class can only be used if the first template argument " - "is a class derived from 'EnableRefCountingByObserverPointer'."); + static_assert(std::is_base_of_v, + "This class can only be used if the first template argument " + "is a class derived from 'EnableObserverPointer'."); if (t != nullptr) t->subscribe(&pointed_to_object_is_alive, id); @@ -314,10 +312,9 @@ inline ObserverPointer::ObserverPointer(T *t, const std::string &id) , id(id) , pointed_to_object_is_alive(false) { - static_assert( - std::is_base_of_v, - "This class can only be used if the first template argument " - "is a class derived from 'EnableRefCountingByObserverPointer'."); + static_assert(std::is_base_of_v, + "This class can only be used if the first template argument " + "is a class derived from 'EnableObserverPointer'."); if (pointer != nullptr) pointer->subscribe(&pointed_to_object_is_alive, id); @@ -333,10 +330,9 @@ inline ObserverPointer::ObserverPointer( , id(other.id) , pointed_to_object_is_alive(false) { - static_assert( - std::is_base_of_v, - "This class can only be used if the first template argument " - "is a class derived from 'EnableRefCountingByObserverPointer'."); + static_assert(std::is_base_of_v, + "This class can only be used if the first template argument " + "is a class derived from 'EnableObserverPointer'."); if (other != nullptr) { @@ -356,10 +352,9 @@ inline ObserverPointer::ObserverPointer( , id(other.id) , pointed_to_object_is_alive(false) { - static_assert( - std::is_base_of_v, - "This class can only be used if the first template argument " - "is a class derived from 'EnableRefCountingByObserverPointer'."); + static_assert(std::is_base_of_v, + "This class can only be used if the first template argument " + "is a class derived from 'EnableObserverPointer'."); if (other != nullptr) { @@ -379,10 +374,9 @@ inline ObserverPointer::ObserverPointer( , id(other.id) , pointed_to_object_is_alive(false) { - static_assert( - std::is_base_of_v, - "This class can only be used if the first template argument " - "is a class derived from 'EnableRefCountingByObserverPointer'."); + static_assert(std::is_base_of_v, + "This class can only be used if the first template argument " + "is a class derived from 'EnableObserverPointer'."); if (other != nullptr) { @@ -414,10 +408,9 @@ inline ObserverPointer::ObserverPointer( template inline ObserverPointer::~ObserverPointer() { - static_assert( - std::is_base_of_v, - "This class can only be used if the first template argument " - "is a class derived from 'EnableRefCountingByObserverPointer'."); + static_assert(std::is_base_of_v, + "This class can only be used if the first template argument " + "is a class derived from 'EnableObserverPointer'."); if (pointed_to_object_is_alive && pointer != nullptr) pointer->unsubscribe(&pointed_to_object_is_alive, id); diff --git a/include/deal.II/base/parameter_acceptor.h b/include/deal.II/base/parameter_acceptor.h index 4767f6cd6a..e504416c1e 100644 --- a/include/deal.II/base/parameter_acceptor.h +++ b/include/deal.II/base/parameter_acceptor.h @@ -355,7 +355,7 @@ namespace internal * * See the tutorial program step-60 for an example on how to use this class. */ -class ParameterAcceptor : public EnableRefCountingByObserverPointer +class ParameterAcceptor : public EnableObserverPointer { public: /** diff --git a/include/deal.II/base/parameter_handler.h b/include/deal.II/base/parameter_handler.h index 2bdf932c80..78684558fb 100644 --- a/include/deal.II/base/parameter_handler.h +++ b/include/deal.II/base/parameter_handler.h @@ -851,7 +851,7 @@ class MultipleParameterLoop; * * @ingroup input */ -class ParameterHandler : public EnableRefCountingByObserverPointer +class ParameterHandler : public EnableObserverPointer { public: /** @@ -2330,7 +2330,7 @@ ParameterHandler::save(Archive &ar, const unsigned int) const { // Forward to serialization // function in the base class. - ar &static_cast(*this); + ar &static_cast(*this); ar &*entries.get(); @@ -2350,7 +2350,7 @@ ParameterHandler::load(Archive &ar, const unsigned int) { // Forward to serialization // function in the base class. - ar &static_cast(*this); + ar &static_cast(*this); ar &*entries.get(); diff --git a/include/deal.II/base/polynomial.h b/include/deal.II/base/polynomial.h index dcbfd148b6..eff924ed45 100644 --- a/include/deal.II/base/polynomial.h +++ b/include/deal.II/base/polynomial.h @@ -62,7 +62,7 @@ namespace Polynomials * TensorProductPolynomials class. */ template - class Polynomial : public EnableRefCountingByObserverPointer + class Polynomial : public EnableObserverPointer { public: /** @@ -1031,7 +1031,7 @@ namespace Polynomials Polynomial::serialize(Archive &ar, const unsigned int) { // forward to serialization function in the base class. - ar &static_cast(*this); + ar &static_cast(*this); ar &coefficients; ar &in_lagrange_product_form; ar &lagrange_support_points; diff --git a/include/deal.II/base/polynomials_piecewise.h b/include/deal.II/base/polynomials_piecewise.h index ea7a4ca633..150b011015 100644 --- a/include/deal.II/base/polynomials_piecewise.h +++ b/include/deal.II/base/polynomials_piecewise.h @@ -60,7 +60,7 @@ namespace Polynomials * @ingroup Polynomials */ template - class PiecewisePolynomial : public EnableRefCountingByObserverPointer + class PiecewisePolynomial : public EnableObserverPointer { public: /** @@ -301,7 +301,7 @@ namespace Polynomials PiecewisePolynomial::serialize(Archive &ar, const unsigned int) { // forward to serialization function in the base class. - ar &static_cast(*this); + ar &static_cast(*this); ar &polynomial; ar &n_intervals; ar &interval; diff --git a/include/deal.II/base/quadrature.h b/include/deal.II/base/quadrature.h index a5343b7cfa..25fa249504 100644 --- a/include/deal.II/base/quadrature.h +++ b/include/deal.II/base/quadrature.h @@ -119,7 +119,7 @@ DEAL_II_NAMESPACE_OPEN * as "list of evaluation points". */ template -class Quadrature : public EnableRefCountingByObserverPointer +class Quadrature : public EnableObserverPointer { public: /** @@ -545,7 +545,7 @@ Quadrature::serialize(Archive &ar, const unsigned int) { // forward to serialization // function in the base class. - ar &static_cast(*this); + ar &static_cast(*this); ar &quadrature_points &weights; } diff --git a/include/deal.II/base/quadrature_point_data.h b/include/deal.II/base/quadrature_point_data.h index 97ed456a92..5dd88393ff 100644 --- a/include/deal.II/base/quadrature_point_data.h +++ b/include/deal.II/base/quadrature_point_data.h @@ -60,7 +60,7 @@ DEAL_II_NAMESPACE_OPEN * for example, adopting a level-set approach to describe material behavior. */ template -class CellDataStorage : public EnableRefCountingByObserverPointer +class CellDataStorage : public EnableObserverPointer { public: /** diff --git a/include/deal.II/base/table.h b/include/deal.II/base/table.h index 4aa281b424..e9bda5dc47 100644 --- a/include/deal.II/base/table.h +++ b/include/deal.II/base/table.h @@ -437,7 +437,7 @@ namespace internal * @ingroup data */ template -class TableBase : public EnableRefCountingByObserverPointer +class TableBase : public EnableObserverPointer { public: using value_type = T; @@ -2165,7 +2165,7 @@ TableBase::TableBase(const TableIndices &sizes, template TableBase::TableBase(const TableBase &src) - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , values(src.values) , table_size(src.table_size) {} @@ -2185,7 +2185,7 @@ TableBase::TableBase(const TableBase &src) template TableBase::TableBase(TableBase &&src) noexcept - : EnableRefCountingByObserverPointer(std::move(src)) + : EnableObserverPointer(std::move(src)) , values(std::move(src.values)) , table_size(src.table_size) { @@ -2199,7 +2199,7 @@ template inline void TableBase::serialize(Archive &ar, const unsigned int) { - ar &static_cast(*this); + ar &static_cast(*this); ar &values &table_size; } @@ -2342,8 +2342,8 @@ template inline TableBase & TableBase::operator=(TableBase &&m) noexcept { - static_cast(*this) = - std::move(static_cast(m)); + static_cast(*this) = + std::move(static_cast(m)); values = std::move(m.values); table_size = m.table_size; m.table_size = TableIndices(); diff --git a/include/deal.II/base/tensor_function.h b/include/deal.II/base/tensor_function.h index 63d1f68db4..5a8b927643 100644 --- a/include/deal.II/base/tensor_function.h +++ b/include/deal.II/base/tensor_function.h @@ -54,7 +54,7 @@ DEAL_II_NAMESPACE_OPEN template class TensorFunction : public FunctionTime::real_type>, - public EnableRefCountingByObserverPointer + public EnableObserverPointer { public: /** diff --git a/include/deal.II/distributed/repartitioning_policy_tools.h b/include/deal.II/distributed/repartitioning_policy_tools.h index 811c57b96a..db980b02b4 100644 --- a/include/deal.II/distributed/repartitioning_policy_tools.h +++ b/include/deal.II/distributed/repartitioning_policy_tools.h @@ -45,7 +45,7 @@ namespace RepartitioningPolicyTools * See the description of RepartitioningPolicyTools for more information. */ template - class Base : public EnableRefCountingByObserverPointer + class Base : public EnableObserverPointer { public: /** diff --git a/include/deal.II/distributed/shared_tria.h b/include/deal.II/distributed/shared_tria.h index b33ea27ab7..ab9c71432f 100644 --- a/include/deal.II/distributed/shared_tria.h +++ b/include/deal.II/distributed/shared_tria.h @@ -545,8 +545,7 @@ namespace internal * for more information about artificial cells. */ template - class TemporarilyRestoreSubdomainIds - : public EnableRefCountingByObserverPointer + class TemporarilyRestoreSubdomainIds : public EnableObserverPointer { public: /** diff --git a/include/deal.II/distributed/tria.h b/include/deal.II/distributed/tria.h index 59b47fa1d9..81f22ef030 100644 --- a/include/deal.II/distributed/tria.h +++ b/include/deal.II/distributed/tria.h @@ -1113,8 +1113,7 @@ namespace parallel * The use of this class is demonstrated in step-75. */ template - class TemporarilyMatchRefineFlags - : public EnableRefCountingByObserverPointer + class TemporarilyMatchRefineFlags : public EnableObserverPointer { public: /** diff --git a/include/deal.II/dofs/block_info.h b/include/deal.II/dofs/block_info.h index ba6f869921..ac02189781 100644 --- a/include/deal.II/dofs/block_info.h +++ b/include/deal.II/dofs/block_info.h @@ -91,7 +91,7 @@ class DoFHandler; * * @ingroup dofs */ -class BlockInfo : public EnableRefCountingByObserverPointer +class BlockInfo : public EnableObserverPointer { public: /** diff --git a/include/deal.II/dofs/dof_handler.h b/include/deal.II/dofs/dof_handler.h index c98c4d88e1..e4aa5223b3 100644 --- a/include/deal.II/dofs/dof_handler.h +++ b/include/deal.II/dofs/dof_handler.h @@ -313,7 +313,7 @@ namespace parallel */ template DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim)) -class DoFHandler : public EnableRefCountingByObserverPointer +class DoFHandler : public EnableObserverPointer { using ActiveSelector = dealii::internal::DoFHandlerImplementation::Iterators; diff --git a/include/deal.II/fe/fe.h b/include/deal.II/fe/fe.h index 10d82f66b4..709750b418 100644 --- a/include/deal.II/fe/fe.h +++ b/include/deal.II/fe/fe.h @@ -651,7 +651,7 @@ class FESystem; * @ingroup febase fe */ template -class FiniteElement : public EnableRefCountingByObserverPointer, +class FiniteElement : public EnableObserverPointer, public FiniteElementData { public: diff --git a/include/deal.II/fe/fe_series.h b/include/deal.II/fe/fe_series.h index d6e407123b..8aa5d6b690 100644 --- a/include/deal.II/fe/fe_series.h +++ b/include/deal.II/fe/fe_series.h @@ -86,7 +86,7 @@ namespace FESeries * $ \bf k $ . */ template - class Fourier : public EnableRefCountingByObserverPointer + class Fourier : public EnableObserverPointer { public: using CoefficientType = typename std::complex; @@ -256,7 +256,7 @@ namespace FESeries * $ \widetilde P_m(x) $ using tensor product rule. */ template - class Legendre : public EnableRefCountingByObserverPointer + class Legendre : public EnableObserverPointer { public: using CoefficientType = double; diff --git a/include/deal.II/fe/fe_tools.h b/include/deal.II/fe/fe_tools.h index c1c99d6b1a..e32dbe0697 100644 --- a/include/deal.II/fe/fe_tools.h +++ b/include/deal.II/fe/fe_tools.h @@ -85,7 +85,7 @@ namespace FETools * FETools::add_fe_name() functions. */ template - class FEFactoryBase : public EnableRefCountingByObserverPointer + class FEFactoryBase : public EnableObserverPointer { public: /** diff --git a/include/deal.II/fe/fe_tools.templates.h b/include/deal.II/fe/fe_tools.templates.h index b138eaed04..505195ec1f 100644 --- a/include/deal.II/fe/fe_tools.templates.h +++ b/include/deal.II/fe/fe_tools.templates.h @@ -1073,8 +1073,7 @@ namespace FETools template void fill_no_codim_fe_names( - std::map> + std::map> &result) { result["FE_Q_Hierarchical"] = @@ -1155,8 +1154,7 @@ namespace FETools template void fill_codim_fe_names( - std::map> + std::map> &result) { result["FE_Bernstein"] = @@ -1197,15 +1195,13 @@ namespace FETools // by the functions above. std::array< std::array< - std::map>, + std::map>, 4>, 4> inline fill_default_map() { std::array< std::array< - std::map>, + std::map>, 4>, 4> result; @@ -1251,16 +1247,14 @@ namespace FETools // each dimension and then separate between them further down inline std::array< std::array< - std::map>, + std::map>, 4>, 4> & get_fe_name_map() { static std::array< std::array< - std::map>, + std::map>, 4>, 4> fe_name_map = fill_default_map(); @@ -2260,7 +2254,7 @@ namespace FETools std::unique_lock lock( internal::FEToolsAddFENameHelper::fe_name_map_lock); internal::FEToolsAddFENameHelper::get_fe_name_map()[dim][spacedim].emplace( - name, std::unique_ptr(factory)); + name, std::unique_ptr(factory)); } @@ -2277,9 +2271,8 @@ namespace FETools std::unique_ptr> get_fe_by_name_ext( std::string &name, - const std::map< - std::string, - std::unique_ptr> + const std::map> &fe_name_map) { // Extract the name of the @@ -2399,7 +2392,7 @@ namespace FETools // argument, which defaults to 1, // so this properly returns // FE_Nothing() - const EnableRefCountingByObserverPointer *ptr = + const EnableObserverPointer *ptr = fe_name_map.find(name_part)->second.get(); const FETools::FEFactoryBase *fef = dynamic_cast *>(ptr); @@ -2425,7 +2418,7 @@ namespace FETools const std::pair tmp = Utilities::get_integer_at_position(name, 0); name.erase(0, tmp.second + 1); - const EnableRefCountingByObserverPointer *ptr = + const EnableObserverPointer *ptr = fe_name_map.find(name_part)->second.get(); const FETools::FEFactoryBase *fef = dynamic_cast *>( @@ -2443,7 +2436,7 @@ namespace FETools Utilities::get_integer_at_position(name, 0); // delete "))" name.erase(0, tmp.second + 2); - const EnableRefCountingByObserverPointer *ptr = + const EnableObserverPointer *ptr = fe_name_map.find(name_part)->second.get(); const FETools::FEFactoryBase *fef = dynamic_cast< @@ -2456,7 +2449,7 @@ namespace FETools Utilities::get_integer_at_position(name, 0); // delete "))" name.erase(0, tmp.second + 2); - const EnableRefCountingByObserverPointer *ptr = + const EnableObserverPointer *ptr = fe_name_map.find(name_part)->second.get(); const FETools::FEFactoryBase *fef = dynamic_cast< @@ -2478,7 +2471,7 @@ namespace FETools Utilities::get_integer_at_position(name, 0); // delete "))" name.erase(0, tmp.second + 2); - const EnableRefCountingByObserverPointer *ptr = + const EnableObserverPointer *ptr = fe_name_map.find(name_part)->second.get(); const FETools::FEFactoryBase *fef = dynamic_cast< diff --git a/include/deal.II/fe/fe_values_base.h b/include/deal.II/fe/fe_values_base.h index 81f57f762b..b938fffc05 100644 --- a/include/deal.II/fe/fe_values_base.h +++ b/include/deal.II/fe/fe_values_base.h @@ -151,7 +151,7 @@ DEAL_II_NAMESPACE_OPEN * @ingroup feaccess */ template -class FEValuesBase : public EnableRefCountingByObserverPointer +class FEValuesBase : public EnableObserverPointer { public: /** diff --git a/include/deal.II/fe/mapping.h b/include/deal.II/fe/mapping.h index 6033285667..3978d43e61 100644 --- a/include/deal.II/fe/mapping.h +++ b/include/deal.II/fe/mapping.h @@ -314,7 +314,7 @@ enum MappingKind * @ingroup mapping */ template -class Mapping : public EnableRefCountingByObserverPointer +class Mapping : public EnableObserverPointer { public: /** diff --git a/include/deal.II/grid/grid_tools_cache.h b/include/deal.II/grid/grid_tools_cache.h index c3ee8e0a47..f1f21613c7 100644 --- a/include/deal.II/grid/grid_tools_cache.h +++ b/include/deal.II/grid/grid_tools_cache.h @@ -63,7 +63,7 @@ namespace GridTools * method mark_for_update() manually. */ template - class Cache : public EnableRefCountingByObserverPointer + class Cache : public EnableObserverPointer { public: /** diff --git a/include/deal.II/grid/intergrid_map.h b/include/deal.II/grid/intergrid_map.h index 4a8dca068c..b81789e16a 100644 --- a/include/deal.II/grid/intergrid_map.h +++ b/include/deal.II/grid/intergrid_map.h @@ -113,7 +113,7 @@ DEAL_II_NAMESPACE_OPEN */ template DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler) -class InterGridMap : public EnableRefCountingByObserverPointer +class InterGridMap : public EnableObserverPointer { public: /** diff --git a/include/deal.II/grid/manifold.h b/include/deal.II/grid/manifold.h index 68a519715b..644f1ae7d7 100644 --- a/include/deal.II/grid/manifold.h +++ b/include/deal.II/grid/manifold.h @@ -282,7 +282,7 @@ namespace Manifolds * @ingroup manifold */ template -class Manifold : public EnableRefCountingByObserverPointer +class Manifold : public EnableObserverPointer { public: // explicitly check for sensible template arguments diff --git a/include/deal.II/grid/tria.h b/include/deal.II/grid/tria.h index c2ad135c40..bab4b37b65 100644 --- a/include/deal.II/grid/tria.h +++ b/include/deal.II/grid/tria.h @@ -1319,7 +1319,7 @@ namespace internal */ template DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim)) -class Triangulation : public EnableRefCountingByObserverPointer +class Triangulation : public EnableObserverPointer { private: /** diff --git a/include/deal.II/hp/collection.h b/include/deal.II/hp/collection.h index fcd1cb939b..4234c32740 100644 --- a/include/deal.II/hp/collection.h +++ b/include/deal.II/hp/collection.h @@ -221,7 +221,7 @@ namespace hp * @ingroup hp hpcollection */ template - class Collection : public EnableRefCountingByObserverPointer + class Collection : public EnableObserverPointer { public: /** diff --git a/include/deal.II/hp/fe_values.h b/include/deal.II/hp/fe_values.h index e4d86ac99c..195251ef83 100644 --- a/include/deal.II/hp/fe_values.h +++ b/include/deal.II/hp/fe_values.h @@ -64,7 +64,7 @@ namespace hp * @ingroup hp */ template - class FEValuesBase : public EnableRefCountingByObserverPointer + class FEValuesBase : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/affine_constraints.h b/include/deal.II/lac/affine_constraints.h index 4a2f6614be..43d2802576 100644 --- a/include/deal.II/lac/affine_constraints.h +++ b/include/deal.II/lac/affine_constraints.h @@ -503,7 +503,7 @@ namespace internal * @ingroup constraints */ template -class AffineConstraints : public EnableRefCountingByObserverPointer +class AffineConstraints : public EnableObserverPointer { public: /** @@ -2370,7 +2370,7 @@ inline AffineConstraints::AffineConstraints( template inline AffineConstraints::AffineConstraints( const AffineConstraints &affine_constraints) - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , lines(affine_constraints.lines) , lines_cache(affine_constraints.lines_cache) , locally_owned_dofs(affine_constraints.locally_owned_dofs) diff --git a/include/deal.II/lac/arpack_solver.h b/include/deal.II/lac/arpack_solver.h index 97c3c0da26..0a23be77bf 100644 --- a/include/deal.II/lac/arpack_solver.h +++ b/include/deal.II/lac/arpack_solver.h @@ -163,7 +163,7 @@ dseupd_(int *rvec, * @ref step_36 "step-36" * for an example. */ -class ArpackSolver : public EnableRefCountingByObserverPointer +class ArpackSolver : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/block_indices.h b/include/deal.II/lac/block_indices.h index 6eae92a4d1..d7ebf02f16 100644 --- a/include/deal.II/lac/block_indices.h +++ b/include/deal.II/lac/block_indices.h @@ -56,7 +56,7 @@ DEAL_II_NAMESPACE_OPEN * @see * @ref GlossBlockLA "Block (linear algebra)" */ -class BlockIndices : public EnableRefCountingByObserverPointer +class BlockIndices : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/block_matrix_base.h b/include/deal.II/lac/block_matrix_base.h index 86601ea0f6..d47f93a25b 100644 --- a/include/deal.II/lac/block_matrix_base.h +++ b/include/deal.II/lac/block_matrix_base.h @@ -346,7 +346,7 @@ namespace BlockMatrixIterators * @ref GlossBlockLA "Block (linear algebra)" */ template -class BlockMatrixBase : public EnableRefCountingByObserverPointer +class BlockMatrixBase : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/block_sparse_matrix_ez.h b/include/deal.II/lac/block_sparse_matrix_ez.h index d0be4a1d0d..1d7a7aa52e 100644 --- a/include/deal.II/lac/block_sparse_matrix_ez.h +++ b/include/deal.II/lac/block_sparse_matrix_ez.h @@ -57,7 +57,7 @@ class BlockVector; * @ref GlossBlockLA "Block (linear algebra)" */ template -class BlockSparseMatrixEZ : public EnableRefCountingByObserverPointer +class BlockSparseMatrixEZ : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/block_sparse_matrix_ez.templates.h b/include/deal.II/lac/block_sparse_matrix_ez.templates.h index 7467ff1330..6b6703f7f7 100644 --- a/include/deal.II/lac/block_sparse_matrix_ez.templates.h +++ b/include/deal.II/lac/block_sparse_matrix_ez.templates.h @@ -82,7 +82,7 @@ BlockSparseMatrixEZ::operator=(const double d) template BlockSparseMatrixEZ::BlockSparseMatrixEZ( const BlockSparseMatrixEZ &m) - : EnableRefCountingByObserverPointer(m) + : EnableObserverPointer(m) , row_indices(m.row_indices) , column_indices(m.column_indices) , blocks(m.blocks) diff --git a/include/deal.II/lac/block_vector_base.h b/include/deal.II/lac/block_vector_base.h index 2e912f16eb..a4c848d9df 100644 --- a/include/deal.II/lac/block_vector_base.h +++ b/include/deal.II/lac/block_vector_base.h @@ -438,7 +438,7 @@ namespace internal * @ref GlossBlockLA "Block (linear algebra)" */ template -class BlockVectorBase : public EnableRefCountingByObserverPointer, +class BlockVectorBase : public EnableObserverPointer, public ReadVector { public: diff --git a/include/deal.II/lac/chunk_sparse_matrix.h b/include/deal.II/lac/chunk_sparse_matrix.h index 6d8ab9cde1..62d7177093 100644 --- a/include/deal.II/lac/chunk_sparse_matrix.h +++ b/include/deal.II/lac/chunk_sparse_matrix.h @@ -445,7 +445,7 @@ DEAL_II_NAMESPACE_OPEN * in the manual). */ template -class ChunkSparseMatrix : public virtual EnableRefCountingByObserverPointer +class ChunkSparseMatrix : public virtual EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/chunk_sparse_matrix.templates.h b/include/deal.II/lac/chunk_sparse_matrix.templates.h index 960b6f4fa1..4c9ffdd107 100644 --- a/include/deal.II/lac/chunk_sparse_matrix.templates.h +++ b/include/deal.II/lac/chunk_sparse_matrix.templates.h @@ -279,7 +279,7 @@ ChunkSparseMatrix::ChunkSparseMatrix() template ChunkSparseMatrix::ChunkSparseMatrix(const ChunkSparseMatrix &m) - : EnableRefCountingByObserverPointer(m) + : EnableObserverPointer(m) , cols(nullptr, "ChunkSparseMatrix") , val(nullptr) , max_len(0) diff --git a/include/deal.II/lac/chunk_sparsity_pattern.h b/include/deal.II/lac/chunk_sparsity_pattern.h index 6391260d64..ac78820adb 100644 --- a/include/deal.II/lac/chunk_sparsity_pattern.h +++ b/include/deal.II/lac/chunk_sparsity_pattern.h @@ -241,7 +241,7 @@ namespace ChunkSparsityPatternIterators * * The use of this class is demonstrated in step-51. */ -class ChunkSparsityPattern : public EnableRefCountingByObserverPointer +class ChunkSparsityPattern : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/diagonal_matrix.h b/include/deal.II/lac/diagonal_matrix.h index e1a8daab0f..03e49b873e 100644 --- a/include/deal.II/lac/diagonal_matrix.h +++ b/include/deal.II/lac/diagonal_matrix.h @@ -58,7 +58,7 @@ namespace LinearAlgebra * @endcode */ template > -class DiagonalMatrix : public EnableRefCountingByObserverPointer +class DiagonalMatrix : public EnableObserverPointer { public: using value_type = typename VectorType::value_type; diff --git a/include/deal.II/lac/la_parallel_vector.h b/include/deal.II/lac/la_parallel_vector.h index 1ad5ce9297..9570c17748 100644 --- a/include/deal.II/lac/la_parallel_vector.h +++ b/include/deal.II/lac/la_parallel_vector.h @@ -247,7 +247,7 @@ namespace LinearAlgebra */ template class Vector : public ::dealii::ReadVector, - public EnableRefCountingByObserverPointer + public EnableObserverPointer { public: using memory_space = MemorySpace; diff --git a/include/deal.II/lac/la_parallel_vector.templates.h b/include/deal.II/lac/la_parallel_vector.templates.h index 1b2799df6f..1d01fb518c 100644 --- a/include/deal.II/lac/la_parallel_vector.templates.h +++ b/include/deal.II/lac/la_parallel_vector.templates.h @@ -730,7 +730,7 @@ namespace LinearAlgebra template Vector::Vector( const Vector &v) - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , allocated_size(0) , vector_is_ghosted(false) , comm_sm(MPI_COMM_SELF) @@ -749,8 +749,8 @@ namespace LinearAlgebra Vector &&v) : Vector() { - static_cast(*this) = - static_cast(v); + static_cast(*this) = + static_cast(v); this->swap(v); } @@ -1428,8 +1428,8 @@ namespace LinearAlgebra Vector::operator=( // NOLINT Vector &&v) { - static_cast(*this) = - static_cast(v); + static_cast(*this) = + static_cast(v); this->swap(v); return *this; } diff --git a/include/deal.II/lac/lapack_full_matrix.h b/include/deal.II/lac/lapack_full_matrix.h index 05a273ca4b..aa15249f94 100644 --- a/include/deal.II/lac/lapack_full_matrix.h +++ b/include/deal.II/lac/lapack_full_matrix.h @@ -1007,7 +1007,7 @@ private: * @ingroup Preconditioners */ template -class PreconditionLU : public EnableRefCountingByObserverPointer +class PreconditionLU : public EnableObserverPointer { public: void diff --git a/include/deal.II/lac/matrix_block.h b/include/deal.II/lac/matrix_block.h index 748dd7e0f4..0f988f9ff4 100644 --- a/include/deal.II/lac/matrix_block.h +++ b/include/deal.II/lac/matrix_block.h @@ -89,7 +89,7 @@ namespace internal * @ref GlossBlockLA "Block (linear algebra)" */ template -class MatrixBlock : public EnableRefCountingByObserverPointer +class MatrixBlock : public EnableObserverPointer { public: /** @@ -419,7 +419,7 @@ public: * @ingroup vector_valued */ template -class MGMatrixBlockVector : public EnableRefCountingByObserverPointer +class MGMatrixBlockVector : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/parpack_solver.h b/include/deal.II/lac/parpack_solver.h index ee7408274d..bf37e51a3f 100644 --- a/include/deal.II/lac/parpack_solver.h +++ b/include/deal.II/lac/parpack_solver.h @@ -207,7 +207,7 @@ extern "C" * PARPACK manual. */ template -class PArpackSolver : public EnableRefCountingByObserverPointer +class PArpackSolver : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/petsc_matrix_base.h b/include/deal.II/lac/petsc_matrix_base.h index 66bfed4e46..190582715b 100644 --- a/include/deal.II/lac/petsc_matrix_base.h +++ b/include/deal.II/lac/petsc_matrix_base.h @@ -291,7 +291,7 @@ namespace PETScWrappers * @ingroup PETScWrappers * @ingroup Matrix1 */ - class MatrixBase : public EnableRefCountingByObserverPointer + class MatrixBase : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/petsc_precondition.h b/include/deal.II/lac/petsc_precondition.h index 556e0caae3..969fe3ea3f 100644 --- a/include/deal.II/lac/petsc_precondition.h +++ b/include/deal.II/lac/petsc_precondition.h @@ -56,7 +56,7 @@ namespace PETScWrappers * * @ingroup PETScWrappers */ - class PreconditionBase : public EnableRefCountingByObserverPointer + class PreconditionBase : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/petsc_snes.h b/include/deal.II/lac/petsc_snes.h index a2afbbf872..324de0ba51 100644 --- a/include/deal.II/lac/petsc_snes.h +++ b/include/deal.II/lac/petsc_snes.h @@ -170,7 +170,7 @@ namespace PETScWrappers * methods: * * @code - * class VectorType : public EnableRefCountingByObserverPointer + * class VectorType : public EnableObserverPointer * ... * explicit VectorType(Vec); * ... @@ -179,7 +179,7 @@ namespace PETScWrappers * @endcode * * @code - * class MatrixType : public EnableRefCountingByObserverPointer + * class MatrixType : public EnableObserverPointer * ... * explicit MatrixType(Mat); * ... diff --git a/include/deal.II/lac/petsc_ts.h b/include/deal.II/lac/petsc_ts.h index 9ac5f5b561..d7bce504d1 100644 --- a/include/deal.II/lac/petsc_ts.h +++ b/include/deal.II/lac/petsc_ts.h @@ -239,7 +239,7 @@ namespace PETScWrappers * methods: * * @code - * class VectorType : public EnableRefCountingByObserverPointer + * class VectorType : public EnableObserverPointer * ... * explicit VectorType(Vec); * ... @@ -248,7 +248,7 @@ namespace PETScWrappers * @endcode * * @code - * class MatrixType : public EnableRefCountingByObserverPointer + * class MatrixType : public EnableObserverPointer * ... * explicit MatrixType(Mat); * ... diff --git a/include/deal.II/lac/petsc_vector_base.h b/include/deal.II/lac/petsc_vector_base.h index 1ecd48c048..5798b44edc 100644 --- a/include/deal.II/lac/petsc_vector_base.h +++ b/include/deal.II/lac/petsc_vector_base.h @@ -250,7 +250,7 @@ namespace PETScWrappers * @ingroup PETScWrappers */ class VectorBase : public ReadVector, - public EnableRefCountingByObserverPointer + public EnableObserverPointer { public: /** @@ -1322,7 +1322,7 @@ namespace PETScWrappers VectorBase::save(Archive &ar, const unsigned int) const { // forward to serialization function in the base class. - ar &static_cast(*this); + ar &static_cast(*this); ar &size(); ar &local_range(); @@ -1344,7 +1344,7 @@ namespace PETScWrappers inline void VectorBase::load(Archive &ar, const unsigned int) { - ar &static_cast(*this); + ar &static_cast(*this); size_type size = 0; std::pair local_range; diff --git a/include/deal.II/lac/precondition.h b/include/deal.II/lac/precondition.h index 1078656c4f..6682077948 100644 --- a/include/deal.II/lac/precondition.h +++ b/include/deal.II/lac/precondition.h @@ -215,7 +215,7 @@ namespace internal * Alternatively, the IdentityMatrix class can be used to precondition in this * way. */ -class PreconditionIdentity : public EnableRefCountingByObserverPointer +class PreconditionIdentity : public EnableObserverPointer { public: /** @@ -330,7 +330,7 @@ private: * multiplied. Still, this class is useful in multigrid smoother objects * (MGSmootherRelaxation). */ -class PreconditionRichardson : public EnableRefCountingByObserverPointer +class PreconditionRichardson : public EnableObserverPointer { public: /** @@ -494,7 +494,7 @@ private: */ template , typename VectorType = Vector> -class PreconditionUseMatrix : public EnableRefCountingByObserverPointer +class PreconditionUseMatrix : public EnableObserverPointer { public: /** @@ -562,7 +562,7 @@ private: */ template , typename PreconditionerType = IdentityMatrix> -class PreconditionRelaxation : public EnableRefCountingByObserverPointer +class PreconditionRelaxation : public EnableObserverPointer { public: /** @@ -2026,7 +2026,7 @@ public: *

    Requirements on the templated classes

    * * The class `MatrixType` must be derived from - * EnableRefCountingByObserverPointer because a ObserverPointer to `MatrixType` + * EnableObserverPointer because a ObserverPointer to `MatrixType` * is held in the class. In particular, this means that the matrix object needs * to persist during the lifetime of PreconditionChebyshev. The preconditioner * is held in a shared_ptr that is copied into the AdditionalData member @@ -2101,7 +2101,7 @@ public: template , typename VectorType = Vector, typename PreconditionerType = DiagonalMatrix> -class PreconditionChebyshev : public EnableRefCountingByObserverPointer +class PreconditionChebyshev : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/precondition_block.h b/include/deal.II/lac/precondition_block.h index 6f00384432..138bf6846f 100644 --- a/include/deal.II/lac/precondition_block.h +++ b/include/deal.II/lac/precondition_block.h @@ -78,7 +78,7 @@ DEAL_II_NAMESPACE_OPEN */ template -class PreconditionBlock : public virtual EnableRefCountingByObserverPointer, +class PreconditionBlock : public virtual EnableObserverPointer, protected PreconditionBlockBase { private: @@ -376,7 +376,7 @@ protected: template class PreconditionBlockJacobi - : public virtual EnableRefCountingByObserverPointer, + : public virtual EnableObserverPointer, private PreconditionBlock { private: @@ -653,7 +653,7 @@ private: template class PreconditionBlockSOR - : public virtual EnableRefCountingByObserverPointer, + : public virtual EnableObserverPointer, protected PreconditionBlock { public: @@ -810,7 +810,7 @@ protected: template class PreconditionBlockSSOR - : public virtual EnableRefCountingByObserverPointer, + : public virtual EnableObserverPointer, private PreconditionBlockSOR { public: diff --git a/include/deal.II/lac/precondition_selector.h b/include/deal.II/lac/precondition_selector.h index ccb982aae2..e6c7e86a0e 100644 --- a/include/deal.II/lac/precondition_selector.h +++ b/include/deal.II/lac/precondition_selector.h @@ -97,7 +97,7 @@ class SparseMatrix; */ template , typename VectorType = dealii::Vector> -class PreconditionSelector : public EnableRefCountingByObserverPointer +class PreconditionSelector : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/read_write_vector.h b/include/deal.II/lac/read_write_vector.h index b49fbcc7e5..a6cd5b885e 100644 --- a/include/deal.II/lac/read_write_vector.h +++ b/include/deal.II/lac/read_write_vector.h @@ -123,7 +123,7 @@ namespace LinearAlgebra * get the first index of the largest range. */ template - class ReadWriteVector : public EnableRefCountingByObserverPointer, + class ReadWriteVector : public EnableObserverPointer, public ReadVector { public: @@ -847,7 +847,7 @@ namespace LinearAlgebra template inline ReadWriteVector::ReadWriteVector( const ReadWriteVector &v) - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() { this->operator=(v); } diff --git a/include/deal.II/lac/relaxation_block.h b/include/deal.II/lac/relaxation_block.h index 3be4b073c8..76987dfc76 100644 --- a/include/deal.II/lac/relaxation_block.h +++ b/include/deal.II/lac/relaxation_block.h @@ -77,7 +77,7 @@ public: * structure in #block_list and an optional ordering of the blocks in * #order. */ - class AdditionalData : public EnableRefCountingByObserverPointer + class AdditionalData : public EnableObserverPointer { public: /** @@ -283,7 +283,7 @@ template > class RelaxationBlockJacobi - : public virtual EnableRefCountingByObserverPointer, + : public virtual EnableObserverPointer, protected RelaxationBlock { public: @@ -379,7 +379,7 @@ template > class RelaxationBlockSOR - : public virtual EnableRefCountingByObserverPointer, + : public virtual EnableObserverPointer, protected RelaxationBlock { public: @@ -475,7 +475,7 @@ template > class RelaxationBlockSSOR - : public virtual EnableRefCountingByObserverPointer, + : public virtual EnableObserverPointer, protected RelaxationBlock { public: diff --git a/include/deal.II/lac/solver.h b/include/deal.II/lac/solver.h index 21f8b7a7b3..285499d755 100644 --- a/include/deal.II/lac/solver.h +++ b/include/deal.II/lac/solver.h @@ -338,7 +338,7 @@ class Vector; */ template > DEAL_II_CXX20_REQUIRES(concepts::is_vector_space_vector) -class SolverBase : public EnableRefCountingByObserverPointer +class SolverBase : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/solver_control.h b/include/deal.II/lac/solver_control.h index 79214b2277..01308b9744 100644 --- a/include/deal.II/lac/solver_control.h +++ b/include/deal.II/lac/solver_control.h @@ -63,7 +63,7 @@ class ParameterHandler; * number of iterations. * */ -class SolverControl : public EnableRefCountingByObserverPointer +class SolverControl : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/solver_selector.h b/include/deal.II/lac/solver_selector.h index 4f939d6ec5..5601e5e680 100644 --- a/include/deal.II/lac/solver_selector.h +++ b/include/deal.II/lac/solver_selector.h @@ -89,7 +89,7 @@ DEAL_II_NAMESPACE_OPEN */ template > DEAL_II_CXX20_REQUIRES(concepts::is_vector_space_vector) -class SolverSelector : public EnableRefCountingByObserverPointer +class SolverSelector : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/sparse_decomposition.h b/include/deal.II/lac/sparse_decomposition.h index 51ae84fa15..9e34565407 100644 --- a/include/deal.II/lac/sparse_decomposition.h +++ b/include/deal.II/lac/sparse_decomposition.h @@ -104,7 +104,7 @@ DEAL_II_NAMESPACE_OPEN */ template class SparseLUDecomposition : protected SparseMatrix, - public virtual EnableRefCountingByObserverPointer + public virtual EnableObserverPointer { protected: /** diff --git a/include/deal.II/lac/sparse_direct.h b/include/deal.II/lac/sparse_direct.h index 4ad3c80ce3..29e9b1a917 100644 --- a/include/deal.II/lac/sparse_direct.h +++ b/include/deal.II/lac/sparse_direct.h @@ -88,7 +88,7 @@ namespace types * * @ingroup Solvers Preconditioners */ -class SparseDirectUMFPACK : public EnableRefCountingByObserverPointer +class SparseDirectUMFPACK : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/sparse_matrix.h b/include/deal.II/lac/sparse_matrix.h index 91b230357a..6d7ac5d93f 100644 --- a/include/deal.II/lac/sparse_matrix.h +++ b/include/deal.II/lac/sparse_matrix.h @@ -516,7 +516,7 @@ DEAL_II_NAMESPACE_OPEN * @ingroup Matrix1 */ template -class SparseMatrix : public virtual EnableRefCountingByObserverPointer +class SparseMatrix : public virtual EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/sparse_matrix.templates.h b/include/deal.II/lac/sparse_matrix.templates.h index d1467be7a8..2af8a963a4 100644 --- a/include/deal.II/lac/sparse_matrix.templates.h +++ b/include/deal.II/lac/sparse_matrix.templates.h @@ -55,7 +55,7 @@ SparseMatrix::SparseMatrix() template SparseMatrix::SparseMatrix(const SparseMatrix &m) - : EnableRefCountingByObserverPointer(m) + : EnableObserverPointer(m) , cols(nullptr, "SparseMatrix") , val(nullptr) , max_len(0) @@ -72,7 +72,7 @@ SparseMatrix::SparseMatrix(const SparseMatrix &m) template SparseMatrix::SparseMatrix(SparseMatrix &&m) noexcept - : EnableRefCountingByObserverPointer(std::move(m)) + : EnableObserverPointer(std::move(m)) , cols(std::move(m.cols)) , val(std::move(m.val)) , max_len(m.max_len) diff --git a/include/deal.II/lac/sparse_matrix_ez.h b/include/deal.II/lac/sparse_matrix_ez.h index 068a9ab940..6d6d9a3232 100644 --- a/include/deal.II/lac/sparse_matrix_ez.h +++ b/include/deal.II/lac/sparse_matrix_ez.h @@ -100,7 +100,7 @@ class FullMatrix; * where "EZ" is pronounced the same way as the word "easy". */ template -class SparseMatrixEZ : public EnableRefCountingByObserverPointer +class SparseMatrixEZ : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/sparse_matrix_ez.templates.h b/include/deal.II/lac/sparse_matrix_ez.templates.h index f63068d73b..5fe550071c 100644 --- a/include/deal.II/lac/sparse_matrix_ez.templates.h +++ b/include/deal.II/lac/sparse_matrix_ez.templates.h @@ -40,7 +40,7 @@ SparseMatrixEZ::SparseMatrixEZ() template SparseMatrixEZ::SparseMatrixEZ(const SparseMatrixEZ &m) - : EnableRefCountingByObserverPointer(m) + : EnableObserverPointer(m) , n_columns(0) , increment(m.increment) , saved_default_row_length(m.saved_default_row_length) diff --git a/include/deal.II/lac/sparsity_pattern.h b/include/deal.II/lac/sparsity_pattern.h index 251c6d9d35..39e11353ef 100644 --- a/include/deal.II/lac/sparsity_pattern.h +++ b/include/deal.II/lac/sparsity_pattern.h @@ -1516,9 +1516,7 @@ inline void SparsityPattern::save(Archive &ar, const unsigned int) const { // forward to serialization function in the base class. - ar & - boost::serialization::base_object( - *this); + ar &boost::serialization::base_object(*this); ar &max_dim &rows &cols &max_vec_len &max_row_length &compressed; @@ -1541,8 +1539,7 @@ inline void SparsityPattern::load(Archive &ar, const unsigned int) { // forward to serialization function in the base class. - ar &boost::serialization::base_object( - *this); + ar &boost::serialization::base_object(*this); ar &max_dim &rows &cols &max_vec_len &max_row_length &compressed; diff --git a/include/deal.II/lac/sparsity_pattern_base.h b/include/deal.II/lac/sparsity_pattern_base.h index aa4a73b182..75effad791 100644 --- a/include/deal.II/lac/sparsity_pattern_base.h +++ b/include/deal.II/lac/sparsity_pattern_base.h @@ -35,7 +35,7 @@ DEAL_II_NAMESPACE_OPEN * Base class for all sparsity patterns, defining a common interface by which * new values can be added. */ -class SparsityPatternBase : public EnableRefCountingByObserverPointer +class SparsityPatternBase : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/trilinos_epetra_vector.h b/include/deal.II/lac/trilinos_epetra_vector.h index 96991c9948..78212ddb0f 100644 --- a/include/deal.II/lac/trilinos_epetra_vector.h +++ b/include/deal.II/lac/trilinos_epetra_vector.h @@ -223,7 +223,7 @@ namespace LinearAlgebra * @ingroup Vectors */ class Vector : public ReadVector, - public EnableRefCountingByObserverPointer + public EnableObserverPointer { public: using value_type = VectorTraits::value_type; diff --git a/include/deal.II/lac/trilinos_precondition.h b/include/deal.II/lac/trilinos_precondition.h index a0e3f085bb..7e0f2344a9 100644 --- a/include/deal.II/lac/trilinos_precondition.h +++ b/include/deal.II/lac/trilinos_precondition.h @@ -73,7 +73,7 @@ namespace TrilinosWrappers * @ingroup TrilinosWrappers * @ingroup Preconditioners */ - class PreconditionBase : public EnableRefCountingByObserverPointer + class PreconditionBase : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/trilinos_solver.h b/include/deal.II/lac/trilinos_solver.h index cc51c68264..ce27cac78a 100644 --- a/include/deal.II/lac/trilinos_solver.h +++ b/include/deal.II/lac/trilinos_solver.h @@ -482,7 +482,7 @@ namespace TrilinosWrappers * * @ingroup TrilinosWrappers */ - class SolverDirect : public EnableRefCountingByObserverPointer + class SolverDirect : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/trilinos_sparse_matrix.h b/include/deal.II/lac/trilinos_sparse_matrix.h index d56ad06519..8e05a1433c 100644 --- a/include/deal.II/lac/trilinos_sparse_matrix.h +++ b/include/deal.II/lac/trilinos_sparse_matrix.h @@ -546,7 +546,7 @@ namespace TrilinosWrappers * @ingroup TrilinosWrappers * @ingroup Matrix1 */ - class SparseMatrix : public EnableRefCountingByObserverPointer + class SparseMatrix : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/trilinos_tpetra_precondition.h b/include/deal.II/lac/trilinos_tpetra_precondition.h index af702dfd97..19d4721429 100644 --- a/include/deal.II/lac/trilinos_tpetra_precondition.h +++ b/include/deal.II/lac/trilinos_tpetra_precondition.h @@ -53,7 +53,7 @@ namespace LinearAlgebra * @ingroup Preconditioners */ template - class PreconditionBase : public EnableRefCountingByObserverPointer + class PreconditionBase : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/trilinos_tpetra_sparse_matrix.h b/include/deal.II/lac/trilinos_tpetra_sparse_matrix.h index 791138c572..1e6af0de7c 100644 --- a/include/deal.II/lac/trilinos_tpetra_sparse_matrix.h +++ b/include/deal.II/lac/trilinos_tpetra_sparse_matrix.h @@ -107,7 +107,7 @@ namespace LinearAlgebra * the matrix, you must call SparseMatrix::compress() again. */ template - class SparseMatrix : public EnableRefCountingByObserverPointer + class SparseMatrix : public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/trilinos_tpetra_vector.h b/include/deal.II/lac/trilinos_tpetra_vector.h index 13d4c819e6..f5e5c89d92 100644 --- a/include/deal.II/lac/trilinos_tpetra_vector.h +++ b/include/deal.II/lac/trilinos_tpetra_vector.h @@ -285,8 +285,7 @@ namespace LinearAlgebra * @ingroup Vectors */ template - class Vector : public ReadVector, - public EnableRefCountingByObserverPointer + class Vector : public ReadVector, public EnableObserverPointer { public: /** diff --git a/include/deal.II/lac/trilinos_tpetra_vector.templates.h b/include/deal.II/lac/trilinos_tpetra_vector.templates.h index 6eec9b7dc5..908d31e0c9 100644 --- a/include/deal.II/lac/trilinos_tpetra_vector.templates.h +++ b/include/deal.II/lac/trilinos_tpetra_vector.templates.h @@ -78,7 +78,7 @@ namespace LinearAlgebra template Vector::Vector() - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , compressed(true) , has_ghost(false) , vector(Utilities::Trilinos::internal::make_rcp< @@ -91,7 +91,7 @@ namespace LinearAlgebra template Vector::Vector(const Vector &V) - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , compressed(V.compressed) , has_ghost(V.has_ghost) , vector(Utilities::Trilinos::internal::make_rcp< @@ -109,7 +109,7 @@ namespace LinearAlgebra template Vector::Vector( const Teuchos::RCP> V) - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , compressed(true) , has_ghost(V->getMap()->isOneToOne() == false) , vector(V) @@ -120,7 +120,7 @@ namespace LinearAlgebra template Vector::Vector(const IndexSet ¶llel_partitioner, const MPI_Comm communicator) - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , compressed(true) , has_ghost(false) , vector(Utilities::Trilinos::internal::make_rcp< @@ -136,7 +136,7 @@ namespace LinearAlgebra const IndexSet &ghost_entries, const MPI_Comm communicator, const bool vector_writable) - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() { if (!vector_writable) { diff --git a/include/deal.II/lac/trilinos_vector.h b/include/deal.II/lac/trilinos_vector.h index e38a07dd13..459b6d3b38 100644 --- a/include/deal.II/lac/trilinos_vector.h +++ b/include/deal.II/lac/trilinos_vector.h @@ -401,7 +401,7 @@ namespace TrilinosWrappers * @ingroup TrilinosWrappers * @ingroup Vectors */ - class Vector : public EnableRefCountingByObserverPointer, + class Vector : public EnableObserverPointer, public ReadVector { public: diff --git a/include/deal.II/lac/vector.h b/include/deal.II/lac/vector.h index 7ec3e32c07..7723b3f8fb 100644 --- a/include/deal.II/lac/vector.h +++ b/include/deal.II/lac/vector.h @@ -116,8 +116,7 @@ namespace parallel * in the manual). */ template -class Vector : public EnableRefCountingByObserverPointer, - public ReadVector +class Vector : public EnableObserverPointer, public ReadVector { public: /** @@ -1481,7 +1480,7 @@ inline void Vector::save(Archive &ar, const unsigned int) const { // forward to serialization function in the base class. - ar &static_cast(*this); + ar &static_cast(*this); ar &values; } @@ -1493,7 +1492,7 @@ inline void Vector::load(Archive &ar, const unsigned int) { // the load stuff again from the archive - ar &static_cast(*this); + ar &static_cast(*this); ar &values; maybe_reset_thread_partitioner(); } diff --git a/include/deal.II/lac/vector.templates.h b/include/deal.II/lac/vector.templates.h index a32065f2fd..f48e063a03 100644 --- a/include/deal.II/lac/vector.templates.h +++ b/include/deal.II/lac/vector.templates.h @@ -52,7 +52,7 @@ DEAL_II_NAMESPACE_OPEN template Vector::Vector(const Vector &v) - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() { *this = v; } diff --git a/include/deal.II/lac/vector_memory.h b/include/deal.II/lac/vector_memory.h index 2545107c4c..45fe9d3a3a 100644 --- a/include/deal.II/lac/vector_memory.h +++ b/include/deal.II/lac/vector_memory.h @@ -101,7 +101,7 @@ DEAL_II_NAMESPACE_OPEN * always returned. */ template > -class VectorMemory : public EnableRefCountingByObserverPointer +class VectorMemory : public EnableObserverPointer { public: /** diff --git a/include/deal.II/matrix_free/fe_remote_evaluation.h b/include/deal.II/matrix_free/fe_remote_evaluation.h index f54d0891cf..8ffcbcfec3 100644 --- a/include/deal.II/matrix_free/fe_remote_evaluation.h +++ b/include/deal.II/matrix_free/fe_remote_evaluation.h @@ -283,7 +283,7 @@ struct FERemoteCommunicationObjectTwoLevel * A class to fill the fields in PrecomputedEvaluationData. */ template -class FERemoteEvaluationCommunicator : public EnableRefCountingByObserverPointer +class FERemoteEvaluationCommunicator : public EnableObserverPointer { public: /** diff --git a/include/deal.II/matrix_free/matrix_free.h b/include/deal.II/matrix_free/matrix_free.h index ca7c7286d6..63df0bb8e3 100644 --- a/include/deal.II/matrix_free/matrix_free.h +++ b/include/deal.II/matrix_free/matrix_free.h @@ -109,7 +109,7 @@ DEAL_II_NAMESPACE_OPEN template > -class MatrixFree : public EnableRefCountingByObserverPointer +class MatrixFree : public EnableObserverPointer { static_assert( std::is_same_v, diff --git a/include/deal.II/matrix_free/matrix_free.templates.h b/include/deal.II/matrix_free/matrix_free.templates.h index 0a80f23e39..2ed4f1a17d 100644 --- a/include/deal.II/matrix_free/matrix_free.templates.h +++ b/include/deal.II/matrix_free/matrix_free.templates.h @@ -77,7 +77,7 @@ DEAL_II_NAMESPACE_OPEN template MatrixFree::MatrixFree() - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , indices_are_initialized(false) , mapping_is_initialized(false) , mg_level(numbers::invalid_unsigned_int) @@ -88,7 +88,7 @@ MatrixFree::MatrixFree() template MatrixFree::MatrixFree( const MatrixFree &other) - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() { copy_from(other); } diff --git a/include/deal.II/matrix_free/operators.h b/include/deal.II/matrix_free/operators.h index e5b6d7fab3..83453a8c00 100644 --- a/include/deal.II/matrix_free/operators.h +++ b/include/deal.II/matrix_free/operators.h @@ -184,7 +184,7 @@ namespace MatrixFreeOperators typename VectorType = LinearAlgebra::distributed::Vector, typename VectorizedArrayType = VectorizedArray> - class Base : public EnableRefCountingByObserverPointer + class Base : public EnableObserverPointer { public: /** @@ -534,7 +534,7 @@ namespace MatrixFreeOperators * prolongation phase. */ template - class MGInterfaceOperator : public EnableRefCountingByObserverPointer + class MGInterfaceOperator : public EnableObserverPointer { public: /** @@ -1215,7 +1215,7 @@ namespace MatrixFreeOperators //----------------- Base operator ----------------------------- template Base::Base() - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , have_interface_matrices(false) {} @@ -1805,7 +1805,7 @@ namespace MatrixFreeOperators template MGInterfaceOperator::MGInterfaceOperator() - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , mf_base_operator(nullptr) {} diff --git a/include/deal.II/matrix_free/portable_matrix_free.h b/include/deal.II/matrix_free/portable_matrix_free.h index 6a20de94f7..8dcfa4e0ee 100644 --- a/include/deal.II/matrix_free/portable_matrix_free.h +++ b/include/deal.II/matrix_free/portable_matrix_free.h @@ -86,7 +86,7 @@ namespace Portable * @note Only float and double are supported. */ template - class MatrixFree : public EnableRefCountingByObserverPointer + class MatrixFree : public EnableObserverPointer { public: using jacobian_type = Tensor<2, dim, Tensor<1, dim, Number>>; diff --git a/include/deal.II/meshworker/local_integrator.h b/include/deal.II/meshworker/local_integrator.h index 75c544944f..31e4864c55 100644 --- a/include/deal.II/meshworker/local_integrator.h +++ b/include/deal.II/meshworker/local_integrator.h @@ -56,8 +56,7 @@ namespace MeshWorker * @ingroup MeshWorker */ template - class DEAL_II_DEPRECATED LocalIntegrator - : public EnableRefCountingByObserverPointer + class DEAL_II_DEPRECATED LocalIntegrator : public EnableObserverPointer { public: /** diff --git a/include/deal.II/meshworker/vector_selector.h b/include/deal.II/meshworker/vector_selector.h index 2f8dc0bc77..e4be3f96d8 100644 --- a/include/deal.II/meshworker/vector_selector.h +++ b/include/deal.II/meshworker/vector_selector.h @@ -44,7 +44,7 @@ namespace MeshWorker * * @ingroup MeshWorker */ - class VectorSelector : public EnableRefCountingByObserverPointer + class VectorSelector : public EnableObserverPointer { public: /** diff --git a/include/deal.II/multigrid/mg_base.h b/include/deal.II/multigrid/mg_base.h index 711849aa46..21f21357fd 100644 --- a/include/deal.II/multigrid/mg_base.h +++ b/include/deal.II/multigrid/mg_base.h @@ -44,7 +44,7 @@ DEAL_II_NAMESPACE_OPEN * of matrices, will be sufficient for applications. */ template -class MGMatrixBase : public EnableRefCountingByObserverPointer +class MGMatrixBase : public EnableObserverPointer { public: /* @@ -104,7 +104,7 @@ public: * will be done by derived classes. */ template -class MGCoarseGridBase : public EnableRefCountingByObserverPointer +class MGCoarseGridBase : public EnableObserverPointer { public: /** @@ -168,7 +168,7 @@ public: * needed. */ template -class MGTransferBase : public EnableRefCountingByObserverPointer +class MGTransferBase : public EnableObserverPointer { public: /** @@ -248,7 +248,7 @@ public: * in the vector @p u given the right hand side, which is done by smooth(). */ template -class MGSmootherBase : public EnableRefCountingByObserverPointer +class MGSmootherBase : public EnableObserverPointer { public: /** diff --git a/include/deal.II/multigrid/mg_constrained_dofs.h b/include/deal.II/multigrid/mg_constrained_dofs.h index 30e5c82851..e9b2bc2264 100644 --- a/include/deal.II/multigrid/mg_constrained_dofs.h +++ b/include/deal.II/multigrid/mg_constrained_dofs.h @@ -41,7 +41,7 @@ class DoFHandler; * * @ingroup mg */ -class MGConstrainedDoFs : public EnableRefCountingByObserverPointer +class MGConstrainedDoFs : public EnableObserverPointer { public: using size_dof = std::vector>::size_type; diff --git a/include/deal.II/multigrid/mg_transfer_global_coarsening.h b/include/deal.II/multigrid/mg_transfer_global_coarsening.h index a269e757b1..941ea96879 100644 --- a/include/deal.II/multigrid/mg_transfer_global_coarsening.h +++ b/include/deal.II/multigrid/mg_transfer_global_coarsening.h @@ -216,7 +216,7 @@ namespace MGTransferGlobalCoarseningTools * accordingly. */ template -class MGTwoLevelTransferBase : public EnableRefCountingByObserverPointer +class MGTwoLevelTransferBase : public EnableObserverPointer { public: static_assert( diff --git a/include/deal.II/multigrid/multigrid.h b/include/deal.II/multigrid/multigrid.h index 6a91501034..1a362d6df9 100644 --- a/include/deal.II/multigrid/multigrid.h +++ b/include/deal.II/multigrid/multigrid.h @@ -159,7 +159,7 @@ namespace mg * MGTransferBase. */ template -class Multigrid : public EnableRefCountingByObserverPointer +class Multigrid : public EnableObserverPointer { public: /** @@ -499,7 +499,7 @@ private: * to be initialized with a separate DoFHandler for each block. */ template -class PreconditionMG : public EnableRefCountingByObserverPointer +class PreconditionMG : public EnableObserverPointer { public: /** diff --git a/include/deal.II/multigrid/sparse_matrix_collection.h b/include/deal.II/multigrid/sparse_matrix_collection.h index b7b2b0530d..84c68276cb 100644 --- a/include/deal.II/multigrid/sparse_matrix_collection.h +++ b/include/deal.II/multigrid/sparse_matrix_collection.h @@ -38,7 +38,7 @@ namespace mg * multigrid with local refinement. */ template - class SparseMatrixCollection : public EnableRefCountingByObserverPointer + class SparseMatrixCollection : public EnableObserverPointer { public: void diff --git a/include/deal.II/non_matching/mapping_info.h b/include/deal.II/non_matching/mapping_info.h index cf2e21dbe5..249e2f8aa6 100644 --- a/include/deal.II/non_matching/mapping_info.h +++ b/include/deal.II/non_matching/mapping_info.h @@ -218,7 +218,7 @@ namespace NonMatching * held. */ template - class MappingInfo : public EnableRefCountingByObserverPointer + class MappingInfo : public EnableObserverPointer { public: /** diff --git a/include/deal.II/non_matching/mesh_classifier.h b/include/deal.II/non_matching/mesh_classifier.h index b5f5e19aae..1458db4770 100644 --- a/include/deal.II/non_matching/mesh_classifier.h +++ b/include/deal.II/non_matching/mesh_classifier.h @@ -105,7 +105,7 @@ namespace NonMatching * same way as for the discrete level set function. */ template - class MeshClassifier : public EnableRefCountingByObserverPointer + class MeshClassifier : public EnableObserverPointer { public: /** diff --git a/include/deal.II/numerics/data_postprocessor.h b/include/deal.II/numerics/data_postprocessor.h index 67270b9e7e..e6d7429d25 100644 --- a/include/deal.II/numerics/data_postprocessor.h +++ b/include/deal.II/numerics/data_postprocessor.h @@ -579,7 +579,7 @@ namespace DataPostprocessorInputs * @ingroup output */ template -class DataPostprocessor : public EnableRefCountingByObserverPointer +class DataPostprocessor : public EnableObserverPointer { public: /** diff --git a/include/deal.II/numerics/time_dependent.h b/include/deal.II/numerics/time_dependent.h index ccab37a762..983fc4f32b 100644 --- a/include/deal.II/numerics/time_dependent.h +++ b/include/deal.II/numerics/time_dependent.h @@ -660,7 +660,7 @@ private: * following grids, and some functions to be called before a new loop over all * time steps is started. */ -class TimeStepBase : public EnableRefCountingByObserverPointer +class TimeStepBase : public EnableObserverPointer { public: /** diff --git a/include/deal.II/particles/particle_handler.h b/include/deal.II/particles/particle_handler.h index 33ce0d3a64..1f94d4b428 100644 --- a/include/deal.II/particles/particle_handler.h +++ b/include/deal.II/particles/particle_handler.h @@ -59,7 +59,7 @@ namespace Particles * finite-element solution see step-19, step-68, step-70, and step-83. */ template - class ParticleHandler : public EnableRefCountingByObserverPointer + class ParticleHandler : public EnableObserverPointer { public: /** diff --git a/source/base/enable_ref_counting_by_observer.cc b/source/base/enable_ref_counting_by_observer.cc index 265ec521df..67984b99fd 100644 --- a/source/base/enable_ref_counting_by_observer.cc +++ b/source/base/enable_ref_counting_by_observer.cc @@ -26,11 +26,11 @@ DEAL_II_NAMESPACE_OPEN static const char *unknown_subscriber = "unknown subscriber"; -std::mutex EnableRefCountingByObserverPointer::mutex; +std::mutex EnableObserverPointer::mutex; -EnableRefCountingByObserverPointer::EnableRefCountingByObserverPointer( - EnableRefCountingByObserverPointer &&subscriptor) noexcept +EnableObserverPointer::EnableObserverPointer( + EnableObserverPointer &&subscriptor) noexcept : counter(0) , object_info(subscriptor.object_info) { @@ -41,7 +41,7 @@ EnableRefCountingByObserverPointer::EnableRefCountingByObserverPointer( -EnableRefCountingByObserverPointer::~EnableRefCountingByObserverPointer() +EnableObserverPointer::~EnableObserverPointer() { for (auto *const validity_ptr : validity_pointers) *validity_ptr = false; @@ -50,7 +50,7 @@ EnableRefCountingByObserverPointer::~EnableRefCountingByObserverPointer() void -EnableRefCountingByObserverPointer::check_no_subscribers() const noexcept +EnableObserverPointer::check_no_subscribers() const noexcept { // Check whether there are still subscriptions to this object. If so, output // the actual name of the class to which this object belongs, i.e. the most @@ -115,9 +115,8 @@ EnableRefCountingByObserverPointer::check_no_subscribers() const noexcept -EnableRefCountingByObserverPointer & -EnableRefCountingByObserverPointer::operator=( - EnableRefCountingByObserverPointer &&s) noexcept +EnableObserverPointer & +EnableObserverPointer::operator=(EnableObserverPointer &&s) noexcept { for (auto *const validity_ptr : s.validity_pointers) *validity_ptr = false; @@ -129,8 +128,8 @@ EnableRefCountingByObserverPointer::operator=( void -EnableRefCountingByObserverPointer::subscribe(std::atomic *const validity, - const std::string &id) const +EnableObserverPointer::subscribe(std::atomic *const validity, + const std::string &id) const { std::lock_guard lock(mutex); @@ -149,9 +148,8 @@ EnableRefCountingByObserverPointer::subscribe(std::atomic *const validity, void -EnableRefCountingByObserverPointer::unsubscribe( - std::atomic *const validity, - const std::string &id) const +EnableObserverPointer::unsubscribe(std::atomic *const validity, + const std::string &id) const { const std::string &name = id.empty() ? unknown_subscriber : id; @@ -186,7 +184,7 @@ EnableRefCountingByObserverPointer::unsubscribe( AssertNothrow( validity_ptr_it != validity_pointers.end(), ExcMessage( - "This EnableRefCountingByObserverPointer object does not know anything about the supplied pointer!")); + "This EnableObserverPointer object does not know anything about the supplied pointer!")); return; } @@ -198,7 +196,7 @@ EnableRefCountingByObserverPointer::unsubscribe( void -EnableRefCountingByObserverPointer::list_subscribers() const +EnableObserverPointer::list_subscribers() const { list_subscribers(deallog); } diff --git a/source/base/quadrature.cc b/source/base/quadrature.cc index 89de89c1d0..461fcedc76 100644 --- a/source/base/quadrature.cc +++ b/source/base/quadrature.cc @@ -244,7 +244,7 @@ Quadrature<1>::Quadrature(const SubQuadrature &, const Quadrature<1> &q2) template <> Quadrature<0>::Quadrature(const Quadrature<1> &) - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , quadrature_points(1) , weights(1, 1.) , is_tensor_product_flag(false) @@ -253,7 +253,7 @@ Quadrature<0>::Quadrature(const Quadrature<1> &) template <> Quadrature<1>::Quadrature(const Quadrature<0> &) - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() { // this function should never be called -- this should be the copy constructor // in 1d... @@ -265,7 +265,7 @@ Quadrature<1>::Quadrature(const Quadrature<0> &) template Quadrature::Quadrature(const Quadrature &q) - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , quadrature_points(Utilities::fixed_power(q.size())) , weights(Utilities::fixed_power(q.size())) , is_tensor_product_flag(true) @@ -303,7 +303,7 @@ Quadrature::Quadrature(const Quadrature &q) template Quadrature::Quadrature(const Quadrature &q) - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , quadrature_points(q.quadrature_points) , weights(q.weights) , is_tensor_product_flag(q.is_tensor_product_flag) diff --git a/source/grid/tria.cc b/source/grid/tria.cc index 573e1e63f6..f066750d17 100644 --- a/source/grid/tria.cc +++ b/source/grid/tria.cc @@ -12022,7 +12022,7 @@ template DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim)) Triangulation::Triangulation( Triangulation &&tria) noexcept - : EnableRefCountingByObserverPointer(std::move(tria)) + : EnableObserverPointer(std::move(tria)) , smooth_grid(tria.smooth_grid) , reference_cells(std::move(tria.reference_cells)) , periodic_face_pairs_level_0(std::move(tria.periodic_face_pairs_level_0)) @@ -12050,7 +12050,7 @@ DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim)) Triangulation &Triangulation::operator=( Triangulation &&tria) noexcept { - EnableRefCountingByObserverPointer::operator=(std::move(tria)); + EnableObserverPointer::operator=(std::move(tria)); smooth_grid = tria.smooth_grid; reference_cells = std::move(tria.reference_cells); diff --git a/source/hp/fe_values.cc b/source/hp/fe_values.cc index 23e985cb0b..5cac943197 100644 --- a/source/hp/fe_values.cc +++ b/source/hp/fe_values.cc @@ -134,7 +134,7 @@ namespace hp template FEValuesBase::FEValuesBase( const FEValuesBase &other) - : EnableRefCountingByObserverPointer(other) + : EnableObserverPointer(other) , fe_collection(other.fe_collection) , mapping_collection(other.mapping_collection) , q_collection(other.q_collection) diff --git a/source/lac/chunk_sparsity_pattern.cc b/source/lac/chunk_sparsity_pattern.cc index a719355da5..c164d7f6f6 100644 --- a/source/lac/chunk_sparsity_pattern.cc +++ b/source/lac/chunk_sparsity_pattern.cc @@ -29,7 +29,7 @@ ChunkSparsityPattern::ChunkSparsityPattern() ChunkSparsityPattern::ChunkSparsityPattern(const ChunkSparsityPattern &s) - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , chunk_size(s.chunk_size) , sparsity_pattern(s.sparsity_pattern) { diff --git a/source/lac/petsc_vector_base.cc b/source/lac/petsc_vector_base.cc index dfa3626af7..9a8534cb31 100644 --- a/source/lac/petsc_vector_base.cc +++ b/source/lac/petsc_vector_base.cc @@ -128,7 +128,7 @@ namespace PETScWrappers VectorBase::VectorBase(const VectorBase &v) - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , ghosted(v.ghosted) , ghost_indices(v.ghost_indices) , last_action(VectorOperation::unknown) @@ -143,7 +143,7 @@ namespace PETScWrappers VectorBase::VectorBase(const Vec &v) - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , vector(v) , ghosted(false) , last_action(VectorOperation::unknown) diff --git a/source/lac/trilinos_epetra_vector.cc b/source/lac/trilinos_epetra_vector.cc index 0ddaa7e7eb..d468afbd1e 100644 --- a/source/lac/trilinos_epetra_vector.cc +++ b/source/lac/trilinos_epetra_vector.cc @@ -81,7 +81,7 @@ namespace LinearAlgebra # endif Vector::Vector() - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , vector(new Epetra_FEVector( Epetra_Map(0, 0, 0, Utilities::Trilinos::comm_self()))) {} @@ -89,7 +89,7 @@ namespace LinearAlgebra Vector::Vector(const Vector &V) - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , vector(new Epetra_FEVector(V.trilinos_vector())) {} @@ -97,7 +97,7 @@ namespace LinearAlgebra Vector::Vector(const IndexSet ¶llel_partitioner, const MPI_Comm communicator) - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , vector(new Epetra_FEVector( parallel_partitioner.make_trilinos_map(communicator, false))) {} diff --git a/source/lac/trilinos_vector.cc b/source/lac/trilinos_vector.cc index 6af1b3e8e3..2c8fad8ca1 100644 --- a/source/lac/trilinos_vector.cc +++ b/source/lac/trilinos_vector.cc @@ -77,7 +77,7 @@ namespace TrilinosWrappers namespace MPI { Vector::Vector() - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() , last_action(Zero) , compressed(true) , has_ghosts(false) @@ -110,8 +110,8 @@ namespace TrilinosWrappers : Vector() { // initialize a minimal, valid object and swap - static_cast(*this) = - static_cast(v); + static_cast(*this) = + static_cast(v); swap(v); } @@ -523,8 +523,8 @@ namespace TrilinosWrappers Vector & Vector::operator=(Vector &&v) noexcept { - static_cast(*this) = - static_cast(v); + static_cast(*this) = + static_cast(v); swap(v); return *this; } diff --git a/tests/algorithms/newton_01.cc b/tests/algorithms/newton_01.cc index f8adea55fc..7be6f3cbab 100644 --- a/tests/algorithms/newton_01.cc +++ b/tests/algorithms/newton_01.cc @@ -24,7 +24,7 @@ // test computing square root of 2 with newton's method -class SquareRoot : public EnableRefCountingByObserverPointer +class SquareRoot : public EnableObserverPointer { public: void diff --git a/tests/base/assign_subscriptor.cc b/tests/base/assign_subscriptor.cc index 994fe0b669..4a017416de 100644 --- a/tests/base/assign_subscriptor.cc +++ b/tests/base/assign_subscriptor.cc @@ -14,7 +14,7 @@ -// Check the behavior of the ObserverPointer-EnableRefCountingByObserverPointer +// Check the behavior of the ObserverPointer-EnableObserverPointer // pair for copy and move semantics. @@ -26,7 +26,7 @@ #include "../tests.h" -class Test : public EnableRefCountingByObserverPointer +class Test : public EnableObserverPointer {}; int @@ -39,12 +39,10 @@ main() { deallog << "Checking copy assignment" << std::endl; - EnableRefCountingByObserverPointer subscriptor_1; - EnableRefCountingByObserverPointer subscriptor_2; - ObserverPointer smart_pointer_1( - &subscriptor_1); - ObserverPointer smart_pointer_2( - &subscriptor_2); + EnableObserverPointer subscriptor_1; + EnableObserverPointer subscriptor_2; + ObserverPointer smart_pointer_1(&subscriptor_1); + ObserverPointer smart_pointer_2(&subscriptor_2); subscriptor_2 = subscriptor_1; @@ -75,11 +73,10 @@ main() { deallog << "Checking copy construction" << std::endl; - EnableRefCountingByObserverPointer subscriptor_1; - ObserverPointer smart_pointer_1( - &subscriptor_1); + EnableObserverPointer subscriptor_1; + ObserverPointer smart_pointer_1(&subscriptor_1); - EnableRefCountingByObserverPointer subscriptor_2(subscriptor_1); + EnableObserverPointer subscriptor_2(subscriptor_1); deallog << "Checking smart_pointer_1" << std::endl; try @@ -97,12 +94,10 @@ main() { deallog << "Checking move assignment" << std::endl; - EnableRefCountingByObserverPointer subscriptor_1; - EnableRefCountingByObserverPointer subscriptor_2; - ObserverPointer smart_pointer_1( - &subscriptor_1); - ObserverPointer smart_pointer_2( - &subscriptor_2); + EnableObserverPointer subscriptor_1; + EnableObserverPointer subscriptor_2; + ObserverPointer smart_pointer_1(&subscriptor_1); + ObserverPointer smart_pointer_2(&subscriptor_2); subscriptor_2 = std::move(subscriptor_1); @@ -133,11 +128,10 @@ main() { deallog << "Checking move construction" << std::endl; - EnableRefCountingByObserverPointer subscriptor_1; - ObserverPointer smart_pointer_1( - &subscriptor_1); + EnableObserverPointer subscriptor_1; + ObserverPointer smart_pointer_1(&subscriptor_1); - EnableRefCountingByObserverPointer subscriptor_2(std::move(subscriptor_1)); + EnableObserverPointer subscriptor_2(std::move(subscriptor_1)); deallog << "Checking smart_pointer_1" << std::endl; try diff --git a/tests/base/reference.cc b/tests/base/reference.cc index 36fde02d78..0c889ed98c 100644 --- a/tests/base/reference.cc +++ b/tests/base/reference.cc @@ -32,7 +32,7 @@ std::vector memory(10000); int next = 0; -class Test : public EnableRefCountingByObserverPointer +class Test : public EnableObserverPointer { const char *name; diff --git a/tests/base/smart_pointer_01.cc b/tests/base/smart_pointer_01.cc index b57800ac1a..b05f106525 100644 --- a/tests/base/smart_pointer_01.cc +++ b/tests/base/smart_pointer_01.cc @@ -27,7 +27,7 @@ #include "../tests.h" -class Test : public EnableRefCountingByObserverPointer +class Test : public EnableObserverPointer {}; diff --git a/tests/base/smart_pointer_02.cc b/tests/base/smart_pointer_02.cc index 377fdebf27..7a998648ed 100644 --- a/tests/base/smart_pointer_02.cc +++ b/tests/base/smart_pointer_02.cc @@ -28,7 +28,7 @@ #include "../tests.h" -class Test : public EnableRefCountingByObserverPointer +class Test : public EnableObserverPointer {}; diff --git a/tests/base/unsubscribe_subscriptor.cc b/tests/base/unsubscribe_subscriptor.cc index 46b319aa35..880d9f167c 100644 --- a/tests/base/unsubscribe_subscriptor.cc +++ b/tests/base/unsubscribe_subscriptor.cc @@ -25,7 +25,7 @@ #include "../tests.h" -class Test : public EnableRefCountingByObserverPointer +class Test : public EnableObserverPointer {}; int @@ -35,10 +35,10 @@ main() initlog(); - EnableRefCountingByObserverPointer subscriptor; - std::atomic dummy_a; - const char *foo_a = "a"; - const char *foo_b = "b"; + EnableObserverPointer subscriptor; + std::atomic dummy_a; + const char *foo_a = "a"; + const char *foo_b = "b"; subscriptor.subscribe(&dummy_a, foo_a); subscriptor.unsubscribe(&dummy_a, foo_b); std::atomic dummy_b; diff --git a/tests/base/unsubscribe_subscriptor.debug.output b/tests/base/unsubscribe_subscriptor.debug.output index 401fd196bf..249be17af7 100644 --- a/tests/base/unsubscribe_subscriptor.debug.output +++ b/tests/base/unsubscribe_subscriptor.debug.output @@ -3,24 +3,24 @@ DEAL::Exception: ExcNoSubscriber(object_info->name(), name) DEAL:: -------------------------------------------------------- An error occurred in file in function - void dealii::EnableRefCountingByObserverPointer::unsubscribe(std::atomic*, const string&) const + void dealii::EnableObserverPointer::unsubscribe(std::atomic*, const string&) const The violated condition was: it != counter_map.end() Additional information: No subscriber with identifier subscribes to this object of class - N6dealii34EnableRefCountingByObserverPointerE. Consequently, it cannot - be unsubscribed. + N6dealii21EnableObserverPointerE. Consequently, it cannot be + unsubscribed. -------------------------------------------------------- -DEAL::Exception: ExcMessage( "This EnableRefCountingByObserverPointer object does not know anything about the supplied pointer!") +DEAL::Exception: ExcMessage( "This EnableObserverPointer object does not know anything about the supplied pointer!") DEAL:: -------------------------------------------------------- An error occurred in file in function - void dealii::EnableRefCountingByObserverPointer::unsubscribe(std::atomic*, const string&) const + void dealii::EnableObserverPointer::unsubscribe(std::atomic*, const string&) const The violated condition was: validity_ptr_it != validity_pointers.end() Additional information: - This EnableRefCountingByObserverPointer object does not know anything - about the supplied pointer! + This EnableObserverPointer object does not know anything about the + supplied pointer! -------------------------------------------------------- diff --git a/tests/base/unsubscribe_subscriptor.debug.output.clang-6 b/tests/base/unsubscribe_subscriptor.debug.output.clang-6 index 319d80b422..b98b7259b9 100644 --- a/tests/base/unsubscribe_subscriptor.debug.output.clang-6 +++ b/tests/base/unsubscribe_subscriptor.debug.output.clang-6 @@ -3,24 +3,24 @@ DEAL::Exception: ExcNoSubscriber(object_info->name(), name) DEAL:: -------------------------------------------------------- An error occurred in file in function - void dealii::EnableRefCountingByObserverPointer::unsubscribe(std::atomic *const, const std::string &) const + void dealii::EnableObserverPointer::unsubscribe(std::atomic *const, const std::string &) const The violated condition was: it != counter_map.end() Additional information: No subscriber with identifier subscribes to this object of class - N6dealii34EnableRefCountingByObserverPointerE. Consequently, it cannot - be unsubscribed. + N6dealii21EnableObserverPointerE. Consequently, it cannot be + unsubscribed. -------------------------------------------------------- -DEAL::Exception: ExcMessage( "This EnableRefCountingByObserverPointer object does not know anything about the supplied pointer!") +DEAL::Exception: ExcMessage( "This EnableObserverPointer object does not know anything about the supplied pointer!") DEAL:: -------------------------------------------------------- An error occurred in file in function - void dealii::EnableRefCountingByObserverPointer::unsubscribe(std::atomic *const, const std::string &) const + void dealii::EnableObserverPointer::unsubscribe(std::atomic *const, const std::string &) const The violated condition was: validity_ptr_it != validity_pointers.end() Additional information: - This EnableRefCountingByObserverPointer object does not know anything - about the supplied pointer! + This EnableObserverPointer object does not know anything about the + supplied pointer! -------------------------------------------------------- diff --git a/tests/base/unsubscribe_subscriptor.debug.output.gcc-12 b/tests/base/unsubscribe_subscriptor.debug.output.gcc-12 index 17fdf90904..013cba366d 100644 --- a/tests/base/unsubscribe_subscriptor.debug.output.gcc-12 +++ b/tests/base/unsubscribe_subscriptor.debug.output.gcc-12 @@ -3,24 +3,24 @@ DEAL::Exception: ExcNoSubscriber(object_info->name(), name) DEAL:: -------------------------------------------------------- An error occurred in file in function - void dealii::EnableRefCountingByObserverPointer::unsubscribe(std::atomic*, const std::string&) const + void dealii::EnableObserverPointer::unsubscribe(std::atomic*, const std::string&) const The violated condition was: it != counter_map.end() Additional information: No subscriber with identifier subscribes to this object of class - N6dealii34EnableRefCountingByObserverPointerE. Consequently, it cannot - be unsubscribed. + N6dealii21EnableObserverPointerE. Consequently, it cannot be + unsubscribed. -------------------------------------------------------- -DEAL::Exception: ExcMessage( "This EnableRefCountingByObserverPointer object does not know anything about the supplied pointer!") +DEAL::Exception: ExcMessage( "This EnableObserverPointer object does not know anything about the supplied pointer!") DEAL:: -------------------------------------------------------- An error occurred in file in function - void dealii::EnableRefCountingByObserverPointer::unsubscribe(std::atomic*, const std::string&) const + void dealii::EnableObserverPointer::unsubscribe(std::atomic*, const std::string&) const The violated condition was: validity_ptr_it != validity_pointers.end() Additional information: - This EnableRefCountingByObserverPointer object does not know anything - about the supplied pointer! + This EnableObserverPointer object does not know anything about the + supplied pointer! -------------------------------------------------------- diff --git a/tests/base/unsubscribe_subscriptor.debug.output.intel b/tests/base/unsubscribe_subscriptor.debug.output.intel index f88e75f4e2..27d7542855 100644 --- a/tests/base/unsubscribe_subscriptor.debug.output.intel +++ b/tests/base/unsubscribe_subscriptor.debug.output.intel @@ -3,24 +3,24 @@ DEAL::Exception: ExcNoSubscriber(object_info->name(), name) DEAL:: -------------------------------------------------------- An error occurred in file in function - void dealii::EnableRefCountingByObserverPointer::unsubscribe(std::atomic *, const std::__cxx11::basic_string, std::allocator> &) const + void dealii::EnableObserverPointer::unsubscribe(std::atomic *, const std::__cxx11::basic_string, std::allocator> &) const The violated condition was: it != counter_map.end() Additional information: No subscriber with identifier subscribes to this object of class - N6dealii34EnableRefCountingByObserverPointerE. Consequently, it cannot - be unsubscribed. + N6dealii21EnableObserverPointerE. Consequently, it cannot be + unsubscribed. -------------------------------------------------------- -DEAL::Exception: ExcMessage( "This EnableRefCountingByObserverPointer object does not know anything about the supplied pointer!") +DEAL::Exception: ExcMessage( "This EnableObserverPointer object does not know anything about the supplied pointer!") DEAL:: -------------------------------------------------------- An error occurred in file in function - void dealii::EnableRefCountingByObserverPointer::unsubscribe(std::atomic *, const std::__cxx11::basic_string, std::allocator> &) const + void dealii::EnableObserverPointer::unsubscribe(std::atomic *, const std::__cxx11::basic_string, std::allocator> &) const The violated condition was: validity_ptr_it != validity_pointers.end() Additional information: - This EnableRefCountingByObserverPointer object does not know anything - about the supplied pointer! + This EnableObserverPointer object does not know anything about the + supplied pointer! -------------------------------------------------------- diff --git a/tests/base/unsubscribe_subscriptor_01.cc b/tests/base/unsubscribe_subscriptor_01.cc index f122783f4b..0a4e4a03bc 100644 --- a/tests/base/unsubscribe_subscriptor_01.cc +++ b/tests/base/unsubscribe_subscriptor_01.cc @@ -27,7 +27,7 @@ #include "../tests.h" -class Test : public EnableRefCountingByObserverPointer +class Test : public EnableObserverPointer {}; int @@ -37,10 +37,10 @@ main() initlog(); - EnableRefCountingByObserverPointer subscriptor; - std::atomic dummy_a; - const char *foo = "a"; - const std::string foo_string = "a"; + EnableObserverPointer subscriptor; + std::atomic dummy_a; + const char *foo = "a"; + const std::string foo_string = "a"; subscriptor.subscribe(&dummy_a, foo); subscriptor.unsubscribe(&dummy_a, foo_string.c_str()); diff --git a/tests/bits/joa_1.cc b/tests/bits/joa_1.cc index 30e3c994e0..b996d40b7c 100644 --- a/tests/bits/joa_1.cc +++ b/tests/bits/joa_1.cc @@ -288,7 +288,7 @@ LaplaceProblem::LaplaceProblem() // finite element object which counts // how many objects use that finite // element (this is what the -// EnableRefCountingByObserverPointer/ObserverPointer +// EnableObserverPointer/ObserverPointer // class pair is used for, in case // you want something like this for // your own programs; see step-7 for diff --git a/tests/bits/sparse_lu_decomposition_1.cc b/tests/bits/sparse_lu_decomposition_1.cc index d594c9f11c..44364ca7ba 100644 --- a/tests/bits/sparse_lu_decomposition_1.cc +++ b/tests/bits/sparse_lu_decomposition_1.cc @@ -15,7 +15,7 @@ // this file didn't compile at one point in time due to the private // inheritance of SparseMatrix by SparseLUDecomposition, and the -// associated lack of accessibility of the EnableRefCountingByObserverPointer +// associated lack of accessibility of the EnableObserverPointer // functions to the ObserverPointer // // it was fixed around 2003-05-22 diff --git a/tests/bits/step-14.cc b/tests/bits/step-14.cc index 7c866ce7c7..122f9f794a 100644 --- a/tests/bits/step-14.cc +++ b/tests/bits/step-14.cc @@ -866,7 +866,7 @@ namespace LaplaceSolver namespace Data { template - struct SetUpBase : public EnableRefCountingByObserverPointer + struct SetUpBase : public EnableObserverPointer { virtual const Function & get_boundary_values() const = 0; @@ -1095,7 +1095,7 @@ namespace Data namespace DualFunctional { template - class DualFunctionalBase : public EnableRefCountingByObserverPointer + class DualFunctionalBase : public EnableObserverPointer { public: virtual void diff --git a/tests/fe/fe_q_dg0.cc b/tests/fe/fe_q_dg0.cc index 41df113156..a273e46c5f 100644 --- a/tests/fe/fe_q_dg0.cc +++ b/tests/fe/fe_q_dg0.cc @@ -312,7 +312,7 @@ namespace Step22 template - class InverseMatrix : public EnableRefCountingByObserverPointer + class InverseMatrix : public EnableObserverPointer { public: InverseMatrix(const Matrix &m, const Preconditioner &preconditioner); @@ -353,7 +353,7 @@ namespace Step22 } template - class SchurComplement : public EnableRefCountingByObserverPointer + class SchurComplement : public EnableObserverPointer { public: SchurComplement( diff --git a/tests/hp/crash_21.cc b/tests/hp/crash_21.cc index 87c48d9d7a..236e6a5396 100644 --- a/tests/hp/crash_21.cc +++ b/tests/hp/crash_21.cc @@ -52,7 +52,7 @@ namespace Step { template - class Problem : public EnableRefCountingByObserverPointer + class Problem : public EnableObserverPointer { public: Problem(); diff --git a/tests/integrators/cells_and_faces_01.cc b/tests/integrators/cells_and_faces_01.cc index 88c12f552c..5eaa706577 100644 --- a/tests/integrators/cells_and_faces_01.cc +++ b/tests/integrators/cells_and_faces_01.cc @@ -45,7 +45,7 @@ const unsigned int n_functionals = 3; template -class Local : public EnableRefCountingByObserverPointer +class Local : public EnableObserverPointer { public: using CellInfo = EmptyInfo; diff --git a/tests/integrators/functional_01.cc b/tests/integrators/functional_01.cc index e2eee30ffa..4ea5cb2c59 100644 --- a/tests/integrators/functional_01.cc +++ b/tests/integrators/functional_01.cc @@ -43,7 +43,7 @@ const unsigned int n_functionals = 3; template -class Local : public EnableRefCountingByObserverPointer +class Local : public EnableObserverPointer { public: using CellInfo = EmptyInfo; diff --git a/tests/integrators/mesh_worker_01.cc b/tests/integrators/mesh_worker_01.cc index 5324199520..aa837b261a 100644 --- a/tests/integrators/mesh_worker_01.cc +++ b/tests/integrators/mesh_worker_01.cc @@ -39,7 +39,7 @@ // Define a class that fills all available entries in the info objects // with recognizable numbers. template -class Local : public EnableRefCountingByObserverPointer +class Local : public EnableObserverPointer { public: using CellInfo = MeshWorker::IntegrationInfo; diff --git a/tests/integrators/mesh_worker_02.cc b/tests/integrators/mesh_worker_02.cc index 7214cadd13..8f266bc260 100644 --- a/tests/integrators/mesh_worker_02.cc +++ b/tests/integrators/mesh_worker_02.cc @@ -38,7 +38,7 @@ // Use local matrices for Laplacian / interior penalty DG template -class MatrixIntegrator : public EnableRefCountingByObserverPointer +class MatrixIntegrator : public EnableObserverPointer { public: static void diff --git a/tests/integrators/mesh_worker_03.cc b/tests/integrators/mesh_worker_03.cc index f553806aa6..fc221c653c 100644 --- a/tests/integrators/mesh_worker_03.cc +++ b/tests/integrators/mesh_worker_03.cc @@ -39,7 +39,7 @@ // Local integrators fill every matrix entry with 10*block_row + block_col template -class MatrixIntegrator : public EnableRefCountingByObserverPointer +class MatrixIntegrator : public EnableObserverPointer { public: static void diff --git a/tests/integrators/mesh_worker_matrix_01.cc b/tests/integrators/mesh_worker_matrix_01.cc index df017379c7..04b62bab54 100644 --- a/tests/integrators/mesh_worker_matrix_01.cc +++ b/tests/integrators/mesh_worker_matrix_01.cc @@ -40,7 +40,7 @@ // Define a class that fills all available entries in the info objects // with recognizable numbers. template -class Local : public EnableRefCountingByObserverPointer +class Local : public EnableObserverPointer { public: using CellInfo = MeshWorker::IntegrationInfo; diff --git a/tests/lac/precondition_chebyshev_07.cc b/tests/lac/precondition_chebyshev_07.cc index 810e696a64..89a8aa7ea5 100644 --- a/tests/lac/precondition_chebyshev_07.cc +++ b/tests/lac/precondition_chebyshev_07.cc @@ -98,7 +98,7 @@ private: }; template -class MySparseMatrix : public EnableRefCountingByObserverPointer +class MySparseMatrix : public EnableObserverPointer { public: MySparseMatrix(const SparseMatrixType &sparse_matrix) diff --git a/tests/lac/precondition_relaxation_01.cc b/tests/lac/precondition_relaxation_01.cc index 21756826ce..4d4ce9f5a4 100644 --- a/tests/lac/precondition_relaxation_01.cc +++ b/tests/lac/precondition_relaxation_01.cc @@ -97,7 +97,7 @@ private: }; template -class MySparseMatrix : public EnableRefCountingByObserverPointer +class MySparseMatrix : public EnableObserverPointer { public: MySparseMatrix(const SparseMatrixType &sparse_matrix) diff --git a/tests/matrix_free/compare_faces_by_cells.cc b/tests/matrix_free/compare_faces_by_cells.cc index 5530835e22..53f74a0154 100644 --- a/tests/matrix_free/compare_faces_by_cells.cc +++ b/tests/matrix_free/compare_faces_by_cells.cc @@ -47,7 +47,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; diff --git a/tests/matrix_free/multigrid_dg_periodic.cc b/tests/matrix_free/multigrid_dg_periodic.cc index ec5a4e47c8..c8d70b350c 100644 --- a/tests/matrix_free/multigrid_dg_periodic.cc +++ b/tests/matrix_free/multigrid_dg_periodic.cc @@ -55,7 +55,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; diff --git a/tests/matrix_free/multigrid_dg_sip_01.cc b/tests/matrix_free/multigrid_dg_sip_01.cc index 85f620f185..fab22e0a0e 100644 --- a/tests/matrix_free/multigrid_dg_sip_01.cc +++ b/tests/matrix_free/multigrid_dg_sip_01.cc @@ -54,7 +54,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; diff --git a/tests/matrix_free/multigrid_dg_sip_02.cc b/tests/matrix_free/multigrid_dg_sip_02.cc index 3110fa5e49..b7bad6ba76 100644 --- a/tests/matrix_free/multigrid_dg_sip_02.cc +++ b/tests/matrix_free/multigrid_dg_sip_02.cc @@ -55,7 +55,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; diff --git a/tests/matrix_free/parallel_multigrid.cc b/tests/matrix_free/parallel_multigrid.cc index a2546e81fb..4b344eb08a 100644 --- a/tests/matrix_free/parallel_multigrid.cc +++ b/tests/matrix_free/parallel_multigrid.cc @@ -54,7 +54,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: LaplaceOperator(){}; diff --git a/tests/matrix_free/parallel_multigrid_adaptive_01.cc b/tests/matrix_free/parallel_multigrid_adaptive_01.cc index b84ac1c669..92ca3efc36 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_01.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_01.cc @@ -54,7 +54,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: LaplaceOperator(){}; @@ -400,7 +400,7 @@ private: template -class MGInterfaceMatrix : public EnableRefCountingByObserverPointer +class MGInterfaceMatrix : public EnableObserverPointer { public: void diff --git a/tests/matrix_free/parallel_multigrid_adaptive_03.cc b/tests/matrix_free/parallel_multigrid_adaptive_03.cc index 00d2574038..9eda3655ea 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_03.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_03.cc @@ -54,7 +54,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; @@ -407,7 +407,7 @@ private: template -class MGInterfaceMatrix : public EnableRefCountingByObserverPointer +class MGInterfaceMatrix : public EnableObserverPointer { public: void diff --git a/tests/matrix_free/parallel_multigrid_adaptive_05.cc b/tests/matrix_free/parallel_multigrid_adaptive_05.cc index ecfec53f0a..d97546493b 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_05.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_05.cc @@ -51,7 +51,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; @@ -404,7 +404,7 @@ private: template -class MGInterfaceMatrix : public EnableRefCountingByObserverPointer +class MGInterfaceMatrix : public EnableObserverPointer { public: void diff --git a/tests/matrix_free/parallel_multigrid_adaptive_06.cc b/tests/matrix_free/parallel_multigrid_adaptive_06.cc index 6d3dd57fbd..3e77d84e3b 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_06.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_06.cc @@ -75,14 +75,14 @@ template > -class BlockLaplace : public EnableRefCountingByObserverPointer +class BlockLaplace : public EnableObserverPointer { public: using value_type = typename BlockVectorType::value_type; using size_type = typename BlockVectorType::size_type; BlockLaplace() - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() {} void diff --git a/tests/matrix_free/parallel_multigrid_adaptive_07.cc b/tests/matrix_free/parallel_multigrid_adaptive_07.cc index 55f9e7c313..0fdc9ee4e8 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_07.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_07.cc @@ -68,14 +68,14 @@ template > -class BlockLaplace : public EnableRefCountingByObserverPointer +class BlockLaplace : public EnableObserverPointer { public: using value_type = typename BlockVectorType::value_type; using size_type = typename BlockVectorType::size_type; BlockLaplace() - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() {} void diff --git a/tests/matrix_free/parallel_multigrid_fullydistributed.cc b/tests/matrix_free/parallel_multigrid_fullydistributed.cc index 38d6eb06ac..3206ef6d8e 100644 --- a/tests/matrix_free/parallel_multigrid_fullydistributed.cc +++ b/tests/matrix_free/parallel_multigrid_fullydistributed.cc @@ -57,7 +57,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; diff --git a/tests/matrix_free/parallel_multigrid_interleave.cc b/tests/matrix_free/parallel_multigrid_interleave.cc index 7381351c80..005d60caf7 100644 --- a/tests/matrix_free/parallel_multigrid_interleave.cc +++ b/tests/matrix_free/parallel_multigrid_interleave.cc @@ -50,7 +50,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; diff --git a/tests/matrix_free/parallel_multigrid_interleave_renumber.cc b/tests/matrix_free/parallel_multigrid_interleave_renumber.cc index 628ecc31c6..37225953fb 100644 --- a/tests/matrix_free/parallel_multigrid_interleave_renumber.cc +++ b/tests/matrix_free/parallel_multigrid_interleave_renumber.cc @@ -51,7 +51,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; diff --git a/tests/matrix_free/parallel_multigrid_mf.cc b/tests/matrix_free/parallel_multigrid_mf.cc index 5c684dab58..1994600d6f 100644 --- a/tests/matrix_free/parallel_multigrid_mf.cc +++ b/tests/matrix_free/parallel_multigrid_mf.cc @@ -52,7 +52,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; diff --git a/tests/matrix_free/solver_cg_interleave.cc b/tests/matrix_free/solver_cg_interleave.cc index 58d8a87b52..8787bac271 100644 --- a/tests/matrix_free/solver_cg_interleave.cc +++ b/tests/matrix_free/solver_cg_interleave.cc @@ -49,7 +49,7 @@ template -class HelmholtzOperator : public EnableRefCountingByObserverPointer +class HelmholtzOperator : public EnableObserverPointer { public: using value_type = number; diff --git a/tests/matrix_free/step-37.cc b/tests/matrix_free/step-37.cc index c38b44fa6a..52f50f3b60 100644 --- a/tests/matrix_free/step-37.cc +++ b/tests/matrix_free/step-37.cc @@ -118,7 +118,7 @@ namespace Step37 template - class LaplaceOperator : public EnableRefCountingByObserverPointer + class LaplaceOperator : public EnableObserverPointer { public: LaplaceOperator(); @@ -171,7 +171,7 @@ namespace Step37 template LaplaceOperator::LaplaceOperator() - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() {} diff --git a/tests/matrix_free/stokes_computation.cc b/tests/matrix_free/stokes_computation.cc index 0d779619f3..cf8f976ec9 100644 --- a/tests/matrix_free/stokes_computation.cc +++ b/tests/matrix_free/stokes_computation.cc @@ -87,7 +87,7 @@ namespace StokesClass class MassMatrixType, class PreconditionerA, class PreconditionerMp> - class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer + class BlockSchurPreconditioner : public EnableObserverPointer { public: /** diff --git a/tests/matrix_free_kokkos/coefficient_eval_device.cc b/tests/matrix_free_kokkos/coefficient_eval_device.cc index 010aa43544..db5fdaca95 100644 --- a/tests/matrix_free_kokkos/coefficient_eval_device.cc +++ b/tests/matrix_free_kokkos/coefficient_eval_device.cc @@ -75,7 +75,7 @@ DummyOperator::operator()( template -class DummyMatrixFree : public EnableRefCountingByObserverPointer +class DummyMatrixFree : public EnableObserverPointer { public: DummyMatrixFree(const Portable::MatrixFree &data_in, diff --git a/tests/matrix_free_kokkos/matrix_vector_device_mf.h b/tests/matrix_free_kokkos/matrix_vector_device_mf.h index 9d4d437154..49fb2aaaff 100644 --- a/tests/matrix_free_kokkos/matrix_vector_device_mf.h +++ b/tests/matrix_free_kokkos/matrix_vector_device_mf.h @@ -170,7 +170,7 @@ template , int n_q_points_1d = fe_degree + 1> -class MatrixFreeTest : public EnableRefCountingByObserverPointer +class MatrixFreeTest : public EnableObserverPointer { public: MatrixFreeTest(const Portable::MatrixFree &data_in, diff --git a/tests/mpi/mesh_worker_matrix_01.cc b/tests/mpi/mesh_worker_matrix_01.cc index cc10048e62..61bb8e4019 100644 --- a/tests/mpi/mesh_worker_matrix_01.cc +++ b/tests/mpi/mesh_worker_matrix_01.cc @@ -46,7 +46,7 @@ // Define a class that fills all available entries in the info objects // with recognizable numbers. template -class Local : public EnableRefCountingByObserverPointer +class Local : public EnableObserverPointer { public: using CellInfo = MeshWorker::IntegrationInfo; diff --git a/tests/multigrid-global-coarsening/multigrid_dg_periodic.cc b/tests/multigrid-global-coarsening/multigrid_dg_periodic.cc index 2a62b1e7ee..7021a9849a 100644 --- a/tests/multigrid-global-coarsening/multigrid_dg_periodic.cc +++ b/tests/multigrid-global-coarsening/multigrid_dg_periodic.cc @@ -55,7 +55,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; diff --git a/tests/multigrid-global-coarsening/multigrid_dg_sip_01.cc b/tests/multigrid-global-coarsening/multigrid_dg_sip_01.cc index 702da3a742..b3d493e872 100644 --- a/tests/multigrid-global-coarsening/multigrid_dg_sip_01.cc +++ b/tests/multigrid-global-coarsening/multigrid_dg_sip_01.cc @@ -54,7 +54,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; diff --git a/tests/multigrid-global-coarsening/multigrid_dg_sip_02.cc b/tests/multigrid-global-coarsening/multigrid_dg_sip_02.cc index df8fd0782c..d95bff8a8b 100644 --- a/tests/multigrid-global-coarsening/multigrid_dg_sip_02.cc +++ b/tests/multigrid-global-coarsening/multigrid_dg_sip_02.cc @@ -55,7 +55,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; diff --git a/tests/multigrid-global-coarsening/multigrid_util.h b/tests/multigrid-global-coarsening/multigrid_util.h index 754cb0de7f..efcd92a45d 100644 --- a/tests/multigrid-global-coarsening/multigrid_util.h +++ b/tests/multigrid-global-coarsening/multigrid_util.h @@ -58,7 +58,7 @@ #include "../tests.h" template -class Operator : public EnableRefCountingByObserverPointer +class Operator : public EnableObserverPointer { public: using value_type = Number; diff --git a/tests/multigrid-global-coarsening/parallel_multigrid.cc b/tests/multigrid-global-coarsening/parallel_multigrid.cc index 67cbe00685..81b69bf9fc 100644 --- a/tests/multigrid-global-coarsening/parallel_multigrid.cc +++ b/tests/multigrid-global-coarsening/parallel_multigrid.cc @@ -54,7 +54,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: LaplaceOperator(){}; diff --git a/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_01.cc b/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_01.cc index cc79886053..4dd31165df 100644 --- a/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_01.cc +++ b/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_01.cc @@ -54,7 +54,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: LaplaceOperator(){}; @@ -400,7 +400,7 @@ private: template -class MGInterfaceMatrix : public EnableRefCountingByObserverPointer +class MGInterfaceMatrix : public EnableObserverPointer { public: void diff --git a/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_03.cc b/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_03.cc index dc145420d1..4b404743a8 100644 --- a/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_03.cc +++ b/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_03.cc @@ -54,7 +54,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; @@ -407,7 +407,7 @@ private: template -class MGInterfaceMatrix : public EnableRefCountingByObserverPointer +class MGInterfaceMatrix : public EnableObserverPointer { public: void diff --git a/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_05.cc b/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_05.cc index 529da593af..89d726f8a3 100644 --- a/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_05.cc +++ b/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_05.cc @@ -51,7 +51,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; @@ -404,7 +404,7 @@ private: template -class MGInterfaceMatrix : public EnableRefCountingByObserverPointer +class MGInterfaceMatrix : public EnableObserverPointer { public: void diff --git a/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_06.cc b/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_06.cc index f58b47531a..28c6ac7853 100644 --- a/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_06.cc +++ b/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_06.cc @@ -75,14 +75,14 @@ template > -class BlockLaplace : public EnableRefCountingByObserverPointer +class BlockLaplace : public EnableObserverPointer { public: using value_type = typename BlockVectorType::value_type; using size_type = typename BlockVectorType::size_type; BlockLaplace() - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() {} void diff --git a/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_07.cc b/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_07.cc index 7cd7fe8b99..649d9a9a77 100644 --- a/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_07.cc +++ b/tests/multigrid-global-coarsening/parallel_multigrid_adaptive_07.cc @@ -68,14 +68,14 @@ template > -class BlockLaplace : public EnableRefCountingByObserverPointer +class BlockLaplace : public EnableObserverPointer { public: using value_type = typename BlockVectorType::value_type; using size_type = typename BlockVectorType::size_type; BlockLaplace() - : EnableRefCountingByObserverPointer() + : EnableObserverPointer() {} void diff --git a/tests/multigrid-global-coarsening/parallel_multigrid_fullydistributed.cc b/tests/multigrid-global-coarsening/parallel_multigrid_fullydistributed.cc index bcfa3c9648..34f0be9e17 100644 --- a/tests/multigrid-global-coarsening/parallel_multigrid_fullydistributed.cc +++ b/tests/multigrid-global-coarsening/parallel_multigrid_fullydistributed.cc @@ -57,7 +57,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; diff --git a/tests/multigrid-global-coarsening/parallel_multigrid_interleave.cc b/tests/multigrid-global-coarsening/parallel_multigrid_interleave.cc index 75e4ea10ef..ad050023c9 100644 --- a/tests/multigrid-global-coarsening/parallel_multigrid_interleave.cc +++ b/tests/multigrid-global-coarsening/parallel_multigrid_interleave.cc @@ -50,7 +50,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; diff --git a/tests/multigrid-global-coarsening/parallel_multigrid_interleave_renumber.cc b/tests/multigrid-global-coarsening/parallel_multigrid_interleave_renumber.cc index 78fafa8ff1..a94591c612 100644 --- a/tests/multigrid-global-coarsening/parallel_multigrid_interleave_renumber.cc +++ b/tests/multigrid-global-coarsening/parallel_multigrid_interleave_renumber.cc @@ -51,7 +51,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; diff --git a/tests/multigrid-global-coarsening/parallel_multigrid_mf.cc b/tests/multigrid-global-coarsening/parallel_multigrid_mf.cc index 65af18c078..7ec6756496 100644 --- a/tests/multigrid-global-coarsening/parallel_multigrid_mf.cc +++ b/tests/multigrid-global-coarsening/parallel_multigrid_mf.cc @@ -52,7 +52,7 @@ template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; diff --git a/tests/multigrid-global-coarsening/stokes_computation.cc b/tests/multigrid-global-coarsening/stokes_computation.cc index 09237aa19b..ea9d2f5038 100644 --- a/tests/multigrid-global-coarsening/stokes_computation.cc +++ b/tests/multigrid-global-coarsening/stokes_computation.cc @@ -87,7 +87,7 @@ namespace StokesClass class MassMatrixType, class PreconditionerA, class PreconditionerMp> - class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer + class BlockSchurPreconditioner : public EnableObserverPointer { public: /** diff --git a/tests/multigrid/mg_renumbered_02.cc b/tests/multigrid/mg_renumbered_02.cc index b9d540452d..58b35bfdeb 100644 --- a/tests/multigrid/mg_renumbered_02.cc +++ b/tests/multigrid/mg_renumbered_02.cc @@ -142,7 +142,7 @@ diff(Vector &diff, template -class OutputCreator : public EnableRefCountingByObserverPointer +class OutputCreator : public EnableObserverPointer { public: void diff --git a/tests/multigrid/mg_renumbered_03.cc b/tests/multigrid/mg_renumbered_03.cc index d490c12ef3..1d26288c65 100644 --- a/tests/multigrid/mg_renumbered_03.cc +++ b/tests/multigrid/mg_renumbered_03.cc @@ -189,7 +189,7 @@ print(const DoFHandler &dof, } template -class OutputCreator : public EnableRefCountingByObserverPointer +class OutputCreator : public EnableObserverPointer { public: void diff --git a/tests/numerics/no_flux_18.cc b/tests/numerics/no_flux_18.cc index 93fc1c10be..bfad4b552b 100644 --- a/tests/numerics/no_flux_18.cc +++ b/tests/numerics/no_flux_18.cc @@ -88,7 +88,7 @@ namespace StokesClass class MassMatrixType, class PreconditionerA, class PreconditionerMp> - class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer + class BlockSchurPreconditioner : public EnableObserverPointer { public: /** diff --git a/tests/performance/instrumentation_step_22.cc b/tests/performance/instrumentation_step_22.cc index 292bc38b74..491b2d6e1a 100644 --- a/tests/performance/instrumentation_step_22.cc +++ b/tests/performance/instrumentation_step_22.cc @@ -204,7 +204,7 @@ RightHandSide::value_list(const std::vector> &vp, template -class InverseMatrix : public EnableRefCountingByObserverPointer +class InverseMatrix : public EnableObserverPointer { public: InverseMatrix(const MatrixType &m, const PreconditionerType &preconditioner); @@ -243,7 +243,7 @@ InverseMatrix::vmult( template -class SchurComplement : public EnableRefCountingByObserverPointer +class SchurComplement : public EnableObserverPointer { public: SchurComplement( diff --git a/tests/performance/timing_mg_glob_coarsen.cc b/tests/performance/timing_mg_glob_coarsen.cc index ca28f3a6c8..cc6313a7aa 100644 --- a/tests/performance/timing_mg_glob_coarsen.cc +++ b/tests/performance/timing_mg_glob_coarsen.cc @@ -79,7 +79,7 @@ dealii::ConditionalOStream debug_output(std::cout, false); template -class LaplaceOperator : public EnableRefCountingByObserverPointer +class LaplaceOperator : public EnableObserverPointer { public: using value_type = number; diff --git a/tests/performance/timing_step_22.cc b/tests/performance/timing_step_22.cc index 9f44ee99b3..2f1b3d52ca 100644 --- a/tests/performance/timing_step_22.cc +++ b/tests/performance/timing_step_22.cc @@ -202,7 +202,7 @@ RightHandSide::value_list(const std::vector> &vp, template -class InverseMatrix : public EnableRefCountingByObserverPointer +class InverseMatrix : public EnableObserverPointer { public: InverseMatrix(const MatrixType &m, const PreconditionerType &preconditioner); @@ -241,7 +241,7 @@ InverseMatrix::vmult( template -class SchurComplement : public EnableRefCountingByObserverPointer +class SchurComplement : public EnableObserverPointer { public: SchurComplement( diff --git a/tests/petsc/petsc_snes_02.cc b/tests/petsc/petsc_snes_02.cc index 1649405ad9..e463b2dfac 100644 --- a/tests/petsc/petsc_snes_02.cc +++ b/tests/petsc/petsc_snes_02.cc @@ -22,7 +22,7 @@ * and exceptions handling for PETSCWrappers::NonlinearSolver. */ -class VectorType : public EnableRefCountingByObserverPointer +class VectorType : public EnableObserverPointer { public: explicit VectorType(Vec v) @@ -39,7 +39,7 @@ private: Vec v; }; -class MatrixType : public EnableRefCountingByObserverPointer +class MatrixType : public EnableObserverPointer { public: explicit MatrixType(Mat A) diff --git a/tests/petsc/petsc_ts_01.cc b/tests/petsc/petsc_ts_01.cc index 27887db8e4..69fa0d5f2a 100644 --- a/tests/petsc/petsc_ts_01.cc +++ b/tests/petsc/petsc_ts_01.cc @@ -22,7 +22,7 @@ * and exceptions handling for PETSCWrappers::TimeStepper. */ -class VectorType : public EnableRefCountingByObserverPointer +class VectorType : public EnableObserverPointer { public: explicit VectorType(Vec v) @@ -39,7 +39,7 @@ private: Vec v; }; -class MatrixType : public EnableRefCountingByObserverPointer +class MatrixType : public EnableObserverPointer { public: explicit MatrixType(Mat A) diff --git a/tests/simplex/step-31.cc b/tests/simplex/step-31.cc index 7f42cbfe4e..560effa901 100644 --- a/tests/simplex/step-31.cc +++ b/tests/simplex/step-31.cc @@ -129,7 +129,7 @@ namespace Step31 namespace LinearSolvers { template - class InverseMatrix : public EnableRefCountingByObserverPointer + class InverseMatrix : public EnableObserverPointer { public: InverseMatrix(const MatrixType &m, @@ -169,7 +169,7 @@ namespace Step31 } } template - class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer + class BlockSchurPreconditioner : public EnableObserverPointer { public: BlockSchurPreconditioner( diff --git a/tests/simplex/step-55.cc b/tests/simplex/step-55.cc index f519d446f4..e6dffbf5ec 100644 --- a/tests/simplex/step-55.cc +++ b/tests/simplex/step-55.cc @@ -118,7 +118,7 @@ namespace Step55 // with an option to specify a preconditioner, and to allow for different // vector types in the vmult function. template - class InverseMatrix : public EnableRefCountingByObserverPointer + class InverseMatrix : public EnableObserverPointer { public: InverseMatrix(const Matrix &m, const Preconditioner &preconditioner); @@ -170,8 +170,7 @@ namespace Step55 // The class A template class for a simple block diagonal preconditioner // for 2x2 matrices. template - class BlockDiagonalPreconditioner - : public EnableRefCountingByObserverPointer + class BlockDiagonalPreconditioner : public EnableObserverPointer { public: BlockDiagonalPreconditioner(const PreconditionerA &preconditioner_A, diff --git a/tests/simplex/stokes-sv.cc b/tests/simplex/stokes-sv.cc index 1e0818bbb1..81cb4f59f7 100644 --- a/tests/simplex/stokes-sv.cc +++ b/tests/simplex/stokes-sv.cc @@ -259,7 +259,7 @@ namespace Step56 } template - class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer + class BlockSchurPreconditioner : public EnableObserverPointer { public: BlockSchurPreconditioner( -- 2.39.5