]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Rename the class to EnableObserverPointer. 17711/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Fri, 11 Oct 2024 21:14:47 +0000 (15:14 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Sat, 12 Oct 2024 03:29:25 +0000 (21:29 -0600)
200 files changed:
doc/doxygen/headers/coding_conventions.h
doc/doxygen/headers/memory.h
examples/step-14/step-14.cc
examples/step-21/step-21.cc
examples/step-22/doc/results.dox
examples/step-22/step-22.cc
examples/step-29/step-29.cc
examples/step-31/step-31.cc
examples/step-32/step-32.cc
examples/step-37/step-37.cc
examples/step-39/step-39.cc
examples/step-43/step-43.cc
examples/step-45/step-45.cc
examples/step-55/step-55.cc
examples/step-56/step-56.cc
examples/step-57/step-57.cc
examples/step-59/step-59.cc
examples/step-64/step-64.cc
examples/step-66/step-66.cc
examples/step-7/step-7.cc
examples/step-75/step-75.cc
examples/step-83/doc/intro.dox
include/deal.II/algorithms/any_data.h
include/deal.II/algorithms/general_data_storage.h
include/deal.II/algorithms/operator.h
include/deal.II/algorithms/timestep_control.h
include/deal.II/base/enable_ref_counting_by_observer_pointer.h
include/deal.II/base/function.h
include/deal.II/base/logstream.h
include/deal.II/base/mg_level_object.h
include/deal.II/base/observer_pointer.h
include/deal.II/base/parameter_acceptor.h
include/deal.II/base/parameter_handler.h
include/deal.II/base/polynomial.h
include/deal.II/base/polynomials_piecewise.h
include/deal.II/base/quadrature.h
include/deal.II/base/quadrature_point_data.h
include/deal.II/base/table.h
include/deal.II/base/tensor_function.h
include/deal.II/distributed/repartitioning_policy_tools.h
include/deal.II/distributed/shared_tria.h
include/deal.II/distributed/tria.h
include/deal.II/dofs/block_info.h
include/deal.II/dofs/dof_handler.h
include/deal.II/fe/fe.h
include/deal.II/fe/fe_series.h
include/deal.II/fe/fe_tools.h
include/deal.II/fe/fe_tools.templates.h
include/deal.II/fe/fe_values_base.h
include/deal.II/fe/mapping.h
include/deal.II/grid/grid_tools_cache.h
include/deal.II/grid/intergrid_map.h
include/deal.II/grid/manifold.h
include/deal.II/grid/tria.h
include/deal.II/hp/collection.h
include/deal.II/hp/fe_values.h
include/deal.II/lac/affine_constraints.h
include/deal.II/lac/arpack_solver.h
include/deal.II/lac/block_indices.h
include/deal.II/lac/block_matrix_base.h
include/deal.II/lac/block_sparse_matrix_ez.h
include/deal.II/lac/block_sparse_matrix_ez.templates.h
include/deal.II/lac/block_vector_base.h
include/deal.II/lac/chunk_sparse_matrix.h
include/deal.II/lac/chunk_sparse_matrix.templates.h
include/deal.II/lac/chunk_sparsity_pattern.h
include/deal.II/lac/diagonal_matrix.h
include/deal.II/lac/la_parallel_vector.h
include/deal.II/lac/la_parallel_vector.templates.h
include/deal.II/lac/lapack_full_matrix.h
include/deal.II/lac/matrix_block.h
include/deal.II/lac/parpack_solver.h
include/deal.II/lac/petsc_matrix_base.h
include/deal.II/lac/petsc_precondition.h
include/deal.II/lac/petsc_snes.h
include/deal.II/lac/petsc_ts.h
include/deal.II/lac/petsc_vector_base.h
include/deal.II/lac/precondition.h
include/deal.II/lac/precondition_block.h
include/deal.II/lac/precondition_selector.h
include/deal.II/lac/read_write_vector.h
include/deal.II/lac/relaxation_block.h
include/deal.II/lac/solver.h
include/deal.II/lac/solver_control.h
include/deal.II/lac/solver_selector.h
include/deal.II/lac/sparse_decomposition.h
include/deal.II/lac/sparse_direct.h
include/deal.II/lac/sparse_matrix.h
include/deal.II/lac/sparse_matrix.templates.h
include/deal.II/lac/sparse_matrix_ez.h
include/deal.II/lac/sparse_matrix_ez.templates.h
include/deal.II/lac/sparsity_pattern.h
include/deal.II/lac/sparsity_pattern_base.h
include/deal.II/lac/trilinos_epetra_vector.h
include/deal.II/lac/trilinos_precondition.h
include/deal.II/lac/trilinos_solver.h
include/deal.II/lac/trilinos_sparse_matrix.h
include/deal.II/lac/trilinos_tpetra_precondition.h
include/deal.II/lac/trilinos_tpetra_sparse_matrix.h
include/deal.II/lac/trilinos_tpetra_vector.h
include/deal.II/lac/trilinos_tpetra_vector.templates.h
include/deal.II/lac/trilinos_vector.h
include/deal.II/lac/vector.h
include/deal.II/lac/vector.templates.h
include/deal.II/lac/vector_memory.h
include/deal.II/matrix_free/fe_remote_evaluation.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/matrix_free/matrix_free.templates.h
include/deal.II/matrix_free/operators.h
include/deal.II/matrix_free/portable_matrix_free.h
include/deal.II/meshworker/local_integrator.h
include/deal.II/meshworker/vector_selector.h
include/deal.II/multigrid/mg_base.h
include/deal.II/multigrid/mg_constrained_dofs.h
include/deal.II/multigrid/mg_transfer_global_coarsening.h
include/deal.II/multigrid/multigrid.h
include/deal.II/multigrid/sparse_matrix_collection.h
include/deal.II/non_matching/mapping_info.h
include/deal.II/non_matching/mesh_classifier.h
include/deal.II/numerics/data_postprocessor.h
include/deal.II/numerics/time_dependent.h
include/deal.II/particles/particle_handler.h
source/base/enable_ref_counting_by_observer.cc
source/base/quadrature.cc
source/grid/tria.cc
source/hp/fe_values.cc
source/lac/chunk_sparsity_pattern.cc
source/lac/petsc_vector_base.cc
source/lac/trilinos_epetra_vector.cc
source/lac/trilinos_vector.cc
tests/algorithms/newton_01.cc
tests/base/assign_subscriptor.cc
tests/base/reference.cc
tests/base/smart_pointer_01.cc
tests/base/smart_pointer_02.cc
tests/base/unsubscribe_subscriptor.cc
tests/base/unsubscribe_subscriptor.debug.output
tests/base/unsubscribe_subscriptor.debug.output.clang-6
tests/base/unsubscribe_subscriptor.debug.output.gcc-12
tests/base/unsubscribe_subscriptor.debug.output.intel
tests/base/unsubscribe_subscriptor_01.cc
tests/bits/joa_1.cc
tests/bits/sparse_lu_decomposition_1.cc
tests/bits/step-14.cc
tests/fe/fe_q_dg0.cc
tests/hp/crash_21.cc
tests/integrators/cells_and_faces_01.cc
tests/integrators/functional_01.cc
tests/integrators/mesh_worker_01.cc
tests/integrators/mesh_worker_02.cc
tests/integrators/mesh_worker_03.cc
tests/integrators/mesh_worker_matrix_01.cc
tests/lac/precondition_chebyshev_07.cc
tests/lac/precondition_relaxation_01.cc
tests/matrix_free/compare_faces_by_cells.cc
tests/matrix_free/multigrid_dg_periodic.cc
tests/matrix_free/multigrid_dg_sip_01.cc
tests/matrix_free/multigrid_dg_sip_02.cc
tests/matrix_free/parallel_multigrid.cc
tests/matrix_free/parallel_multigrid_adaptive_01.cc
tests/matrix_free/parallel_multigrid_adaptive_03.cc
tests/matrix_free/parallel_multigrid_adaptive_05.cc
tests/matrix_free/parallel_multigrid_adaptive_06.cc
tests/matrix_free/parallel_multigrid_adaptive_07.cc
tests/matrix_free/parallel_multigrid_fullydistributed.cc
tests/matrix_free/parallel_multigrid_interleave.cc
tests/matrix_free/parallel_multigrid_interleave_renumber.cc
tests/matrix_free/parallel_multigrid_mf.cc
tests/matrix_free/solver_cg_interleave.cc
tests/matrix_free/step-37.cc
tests/matrix_free/stokes_computation.cc
tests/matrix_free_kokkos/coefficient_eval_device.cc
tests/matrix_free_kokkos/matrix_vector_device_mf.h
tests/mpi/mesh_worker_matrix_01.cc
tests/multigrid-global-coarsening/multigrid_dg_periodic.cc
tests/multigrid-global-coarsening/multigrid_dg_sip_01.cc
tests/multigrid-global-coarsening/multigrid_dg_sip_02.cc
tests/multigrid-global-coarsening/multigrid_util.h
tests/multigrid-global-coarsening/parallel_multigrid.cc
tests/multigrid-global-coarsening/parallel_multigrid_adaptive_01.cc
tests/multigrid-global-coarsening/parallel_multigrid_adaptive_03.cc
tests/multigrid-global-coarsening/parallel_multigrid_adaptive_05.cc
tests/multigrid-global-coarsening/parallel_multigrid_adaptive_06.cc
tests/multigrid-global-coarsening/parallel_multigrid_adaptive_07.cc
tests/multigrid-global-coarsening/parallel_multigrid_fullydistributed.cc
tests/multigrid-global-coarsening/parallel_multigrid_interleave.cc
tests/multigrid-global-coarsening/parallel_multigrid_interleave_renumber.cc
tests/multigrid-global-coarsening/parallel_multigrid_mf.cc
tests/multigrid-global-coarsening/stokes_computation.cc
tests/multigrid/mg_renumbered_02.cc
tests/multigrid/mg_renumbered_03.cc
tests/numerics/no_flux_18.cc
tests/performance/instrumentation_step_22.cc
tests/performance/timing_mg_glob_coarsen.cc
tests/performance/timing_step_22.cc
tests/petsc/petsc_snes_02.cc
tests/petsc/petsc_ts_01.cc
tests/simplex/step-31.cc
tests/simplex/step-55.cc
tests/simplex/stokes-sv.cc

index d227f0211768ebcf9e706507ca6569bf65cd54a7..7194277f94affb8783f80bfee8d1c3467d95c2ed 100644 (file)
@@ -211,7 +211,7 @@ functions with their own user-defined types by including the
 <code>.templates.h</code> files.
 
 <li> 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 <code>\#ifndef
 DOXYGEN ... \#endif</code> to prevent Doxygen from picking them up.</li>
index fd833ff8c6ca43497219497b2eaec7b8078b240a..7e94df1e60c9ed9df3aa69b365931d5e9ff7b0f8 100644 (file)
@@ -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,
index 9afa6e3c1c3e3fbdd92cb5dbce0c5923e75a8e07..4496a2bac9dfb1eeb115549623df56c4b0e9e243 100644 (file)
@@ -1053,9 +1053,9 @@ namespace Step14
     // Based on the above description, the <code>SetUpBase</code> class then
     // looks as follows. To allow using the <code>ObserverPointer</code> class
     // with this class, we derived from the
-    // <code>EnableRefCountingByObserverPointer</code> class.
+    // <code>EnableObserverPointer</code> class.
     template <int dim>
-    struct SetUpBase : public EnableRefCountingByObserverPointer
+    struct SetUpBase : public EnableObserverPointer
     {
       virtual const Function<dim> &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 <int dim>
-    class DualFunctionalBase : public EnableRefCountingByObserverPointer
+    class DualFunctionalBase : public EnableObserverPointer
     {
     public:
       virtual void assemble_rhs(const DoFHandler<dim> &dof_handler,
index 97719ad2e07b6a86a3bb515aa03965b8388bf633..6dfcb06fb72514a7ef84f5a573292b3f9706c14e 100644 (file)
@@ -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 MatrixType>
-  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<double>           &A,
@@ -460,7 +460,7 @@ namespace Step21
 
 
 
-  class ApproximateSchurComplement : public EnableRefCountingByObserverPointer
+  class ApproximateSchurComplement : public EnableObserverPointer
   {
   public:
     ApproximateSchurComplement(const BlockSparseMatrix<double> &A)
index 0323ad696c35c4f3448ff6e541b8eeda7b35d703..f50903afa72f2f54b24c319d812c922b781e49e0 100644 (file)
@@ -407,7 +407,7 @@ according to the derivation above can be specified by three successive
 operations:
 @code
 template <class PreconditionerA, class PreconditionerMp>
-class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer
+class BlockSchurPreconditioner : public EnableObserverPointer
 {
   public:
     BlockSchurPreconditioner (const BlockSparseMatrix<double>         &S,
index 4c78dbc8871689bae6feb49707e1994c0a3557b7..7f9cf5de7a9b7dced792bb1f8f45cd51273a25f3 100644 (file)
@@ -279,7 +279,7 @@ namespace Step22
   // <code>InverseMatrix</code> object is created. The member function
   // <code>vmult</code> is obtained by solving a linear system:
   template <class MatrixType, class PreconditionerType>
-  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
   // <code>ObserverPointer</code> object <code>m_inverse</code> as well.
   template <class PreconditionerType>
-  class SchurComplement : public EnableRefCountingByObserverPointer
+  class SchurComplement : public EnableObserverPointer
   {
   public:
     SchurComplement(
index 89ed4ec5906eaf3a7de170f6fa60877cae3c03ec..d079904cdcdf6f664b7f149b2ee05db642ab5e42 100644 (file)
@@ -123,7 +123,7 @@ namespace Step29
   // <code>declare_parameters</code> that declares all the necessary
   // parameters and a <code>read_parameters</code> function that is called
   // from outside to initiate the parameter reading process.
-  class ParameterReader : public EnableRefCountingByObserverPointer
+  class ParameterReader : public EnableObserverPointer
   {
   public:
     ParameterReader(ParameterHandler &);
index 76411eaf6238a7a7e63c9ef9a8eb3d939bf687f8..9f7b708e7bb7f2b283fd43d28298fb8148a4116b 100644 (file)
@@ -242,7 +242,7 @@ namespace Step31
     // we can abort the program preserving information about where the
     // problem happened.
     template <class MatrixType, class PreconditionerType>
-    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 PreconditionerTypeA, class PreconditionerTypeMp>
-    class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer
+    class BlockSchurPreconditioner : public EnableObserverPointer
     {
     public:
       BlockSchurPreconditioner(
index 81c889772785eb6ca4586b4f1c38fc21943a22ea..ec940a28fee375e22b346cbc1ebd006cc0306b1a 100644 (file)
@@ -224,7 +224,7 @@ namespace Step32
   namespace LinearSolvers
   {
     template <class PreconditionerTypeA, class PreconditionerTypeMp>
-    class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer
+    class BlockSchurPreconditioner : public EnableObserverPointer
     {
     public:
       BlockSchurPreconditioner(const TrilinosWrappers::BlockSparseMatrix &S,
index b109dc22553a4f616cba8a07539f7ab62a47382d..f6c09edd7cf762bb4ebbcc001f880a51681743b3 100644 (file)
@@ -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 <int dim, int fe_degree, typename number>
   LaplaceOperator<dim, fe_degree, number>::LaplaceOperator()
index a1d5e29b0f9ccb4c606b446e5b2d46271ec7ba71..f4b1541eec7ea9ec5d9e51843b2b6141328fd449 100644 (file)
@@ -621,7 +621,7 @@ namespace Step39
     // It is important to update the sparsity patterns after <tt>clear()</tt>
     // 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);
 
index 76f807ff6ffa42062cf4ab65f8cefef9dc6bf74a..e3babd3dc3538a62439b68ea2851d5f895327638 100644 (file)
@@ -318,7 +318,7 @@ namespace Step43
   namespace LinearSolvers
   {
     template <class MatrixType, class PreconditionerType>
-    class InverseMatrix : public EnableRefCountingByObserverPointer
+    class InverseMatrix : public EnableObserverPointer
     {
     public:
       InverseMatrix(const MatrixType         &m,
@@ -366,7 +366,7 @@ namespace Step43
     }
 
     template <class PreconditionerTypeA, class PreconditionerTypeMp>
-    class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer
+    class BlockSchurPreconditioner : public EnableObserverPointer
     {
     public:
       BlockSchurPreconditioner(
index 5d1f56db0ec2cc1a24ed58d9b4c4a0b6adc5f1b8..6b330b1a69584adb995e9d6a807d35cd645a7cfb 100644 (file)
@@ -185,7 +185,7 @@ namespace Step45
 
 
   template <class MatrixType, class PreconditionerType>
-  class InverseMatrix : public EnableRefCountingByObserverPointer
+  class InverseMatrix : public EnableObserverPointer
   {
   public:
     InverseMatrix(const MatrixType         &m,
index 8577068aa8f7f9d4c89e06fd44ff7d4bf421b4fc..2f64d3c7e94881b987b229d1ec94cbd831f5624d 100644 (file)
@@ -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 Matrix, class Preconditioner>
-    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 PreconditionerA, class PreconditionerS>
-    class BlockDiagonalPreconditioner
-      : public EnableRefCountingByObserverPointer
+    class BlockDiagonalPreconditioner : public EnableObserverPointer
     {
     public:
       BlockDiagonalPreconditioner(const PreconditionerA &preconditioner_A,
index a047f5e1d48fa474e50db88f3e7d07251bb13740..53a4fa2fd793420f06faf9fc9cb8e9f319512ba8 100644 (file)
@@ -301,7 +301,7 @@ namespace Step56
   // Notice how we keep track of the sum of the inner iterations
   // (preconditioner applications).
   template <class PreconditionerAType, class PreconditionerSType>
-  class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer
+  class BlockSchurPreconditioner : public EnableObserverPointer
   {
   public:
     BlockSchurPreconditioner(
index 2a779e0aa4e01273da70aba0f8e1383f5704aedc..f4de39e52dc65fb7caafc3ab7323885395e2f57d 100644 (file)
@@ -182,7 +182,7 @@ namespace Step57
   // positive definite, we can use CG to solve the corresponding linear
   // system.
   template <class PreconditionerMp>
-  class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer
+  class BlockSchurPreconditioner : public EnableObserverPointer
   {
   public:
     BlockSchurPreconditioner(double                           gamma,
index f0490e671a9786165be687ffb2bcb98795b435d0..9755df42e114abb73e37a2601256eeec46356a0f 100644 (file)
@@ -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 <int dim, int fe_degree, typename number>
-  class LaplaceOperator : public EnableRefCountingByObserverPointer
+  class LaplaceOperator : public EnableObserverPointer
   {
   public:
     using value_type = number;
index 8a7004b056bd8320331b816f6eb96c2f07c961d4..276604aa2ec161510f1e5b2adb6a798898ac7543 100644 (file)
@@ -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 <int dim, int fe_degree>
-  class HelmholtzOperator : public EnableRefCountingByObserverPointer
+  class HelmholtzOperator : public EnableObserverPointer
   {
   public:
     HelmholtzOperator(const DoFHandler<dim>           &dof_handler,
index 23b47e5628f116ecca9c8abd2a88d789fa7e4df3..255deb63427f2d0b0474dfde77556e07d87984c8 100644 (file)
@@ -151,7 +151,7 @@ namespace Step66
 
   // The constructor of the <code>JacobianOperator</code> just calls the
   // constructor of the base class MatrixFreeOperators::Base, which is itself
-  // derived from the EnableRefCountingByObserverPointer class.
+  // derived from the EnableObserverPointer class.
   template <int dim, int fe_degree, typename number>
   JacobianOperator<dim, fe_degree, number>::JacobianOperator()
     : MatrixFreeOperators::Base<dim,
index 169d4e0c5ad88bcdfba8c66cada198602e6f3be1..6de898a4ce96848d478e90215caabd1f91088072 100644 (file)
@@ -360,9 +360,9 @@ namespace Step7
     // from the point of view of a using object. Basically, the method is along
     // the following line: all objects that are subject to such potentially
     // dangerous pointers are derived from a class called
-    // EnableRefCountingByObserverPointer. For example, the Triangulation,
+    // EnableObserverPointer. For example, the Triangulation,
     // DoFHandler, and a base class of the FiniteElement class are derived from
-    // EnableRefCountingByObserverPointer. This latter class does not offer much
+    // EnableObserverPointer. This latter class does not offer much
     // functionality, but it has a built-in counter which we can subscribe to,
     // thus the name of the class. Whenever we initialize a pointer to that
     // object, we can increase its use counter, and when we move away our
@@ -372,8 +372,8 @@ namespace Step7
     // to tell the subscribing object about its invalidation.
     //
     // If an object of a class that is derived from the
-    // EnableRefCountingByObserverPointer class is destroyed, it also has to
-    // call the destructor of the EnableRefCountingByObserverPointer class. In
+    // EnableObserverPointer class is destroyed, it also has to
+    // call the destructor of the EnableObserverPointer class. In
     // this destructor, we tell all the subscribing objects about the
     // invalidation of the object using the stored pointers. The same happens
     // when the object appears on the right hand side of a move expression,
index 3c8a5496d14e8ffd86c6f448f424e15a0446ffda..00a4f7db1f3d69f7d3316b2e7c4ebb1786c18233 100644 (file)
@@ -213,7 +213,7 @@ namespace Step75
   // points. Here, we introduce an alias to FEEvaluation with the correct
   // template parameters so that we do not have to worry about them later on.
   template <int dim, typename number>
-  class LaplaceOperator : public EnableRefCountingByObserverPointer
+  class LaplaceOperator : public EnableObserverPointer
   {
   public:
     using VectorType = LinearAlgebra::distributed::Vector<number>;
index e2a5be2fdd28da466bb1e460d2929675ad3b55fd..a38b58adc1c7a305d8dc0bf3cb2ec2cff418e109 100644 (file)
@@ -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 <int dim>
 template <class Archive>
@@ -198,7 +198,7 @@ inline void
 Quadrature<dim>::serialize(Archive &ar, const unsigned int)
 {
   // Forward to the (de)serialization function in the base class:
-  ar & static_cast<EnableRefCountingByObserverPointer &>(*this);
+  ar & static_cast<EnableObserverPointer &>(*this);
 
   // Then (de)serialize the member variables:
   ar & quadrature_points & weights;
index a6680df6d9239481a2ca231bae73768bc56df7b6..a3a03afe381dc0de5600078a0fb78d84ffb5f599 100644 (file)
@@ -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
index 8cfda5419eeb98267c652245f7b47885626dfde7..da3fd8d2ee7447fd10e7113bc746a9de83dfb862 100644 (file)
@@ -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:
   /**
index ec2779fa80b8f6387b25158ea4854a53ba5c5420..9d77ed1638712cdcfeb00e200b027146e8343634 100644 (file)
@@ -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 <typename VectorType>
-  class OutputOperator : public EnableRefCountingByObserverPointer
+  class OutputOperator : public EnableObserverPointer
   {
   public:
     /**
index 2021095e3c6801080c75333e13764c44d216865b..676e26c9c88ae7990d0f5f3d44d9cd88e7780fdb 100644 (file)
@@ -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:
     /**
index 35eeeab75853b14a0be107ef0de1e35576939dfa..32e250f7573445afd3f16f235130292df02f87e2 100644 (file)
@@ -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 <tt>*this</tt>.
    */
-  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 <class Archive>
 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 <typename StreamType>
 inline void
-EnableRefCountingByObserverPointer::list_subscribers(StreamType &stream) const
+EnableObserverPointer::list_subscribers(StreamType &stream) const
 {
   std::lock_guard<std::mutex> lock(mutex);
 
index 5cafbaa95194cf5364d7491d72bc49afdf8a5215..d760a90cad728b5ab162a29ec8619b72363f7f81 100644 (file)
@@ -148,7 +148,7 @@ class TensorFunction;
 template <int dim, typename RangeNumberType = double>
 class Function : public FunctionTime<
                    typename numbers::NumberTraits<RangeNumberType>::real_type>,
-                 public EnableRefCountingByObserverPointer
+                 public EnableObserverPointer
 {
 public:
   /**
index b80dae2822263c5b93761c022548712e0ee60863..68f02aa3bd424183ab29337d16ffb366ec76bacf 100644 (file)
@@ -77,7 +77,7 @@ DEAL_II_NAMESPACE_OPEN
  *
  * @ingroup textoutput
  */
-class LogStream : public EnableRefCountingByObserverPointer
+class LogStream : public EnableObserverPointer
 {
 public:
   /**
index 6a76af25e7d1bea7ca41c93b4a42654ba9c7abc3..ff11c5e9ec388eeb39d35790e37922411f122f27 100644 (file)
@@ -45,7 +45,7 @@ DEAL_II_NAMESPACE_OPEN
  * @ingroup data
  */
 template <class Object>
-class MGLevelObject : public EnableRefCountingByObserverPointer
+class MGLevelObject : public EnableObserverPointer
 {
 public:
   /**
index 4ed8c8fa7398a2f095a88ac4c5c8a196a1b4fb83..2ea771aedc01f52b49c6f26fff1866c8fcd9198a 100644 (file)
@@ -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<T>` is a mutable pointer.
  *
- * @dealiiConceptRequires{std::is_base_of_v<EnableRefCountingByObserverPointer,
+ * @dealiiConceptRequires{std::is_base_of_v<EnableObserverPointer,
  * T>}
  *
  * @ingroup memory
@@ -135,8 +135,8 @@ public:
    * lock it, i.e. to prevent its destruction before the end of its use.
    *
    * The <tt>id</tt> 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<T, P>::ObserverPointer()
   , id(typeid(P).name())
   , pointed_to_object_is_alive(false)
 {
-  static_assert(
-    std::is_base_of_v<EnableRefCountingByObserverPointer, T>,
-    "This class can only be used if the first template argument "
-    "is a class derived from 'EnableRefCountingByObserverPointer'.");
+  static_assert(std::is_base_of_v<EnableObserverPointer, T>,
+                "This class can only be used if the first template argument "
+                "is a class derived from 'EnableObserverPointer'.");
 }
 
 
@@ -297,10 +296,9 @@ inline ObserverPointer<T, P>::ObserverPointer(T *t)
   , id(typeid(P).name())
   , pointed_to_object_is_alive(false)
 {
-  static_assert(
-    std::is_base_of_v<EnableRefCountingByObserverPointer, T>,
-    "This class can only be used if the first template argument "
-    "is a class derived from 'EnableRefCountingByObserverPointer'.");
+  static_assert(std::is_base_of_v<EnableObserverPointer, T>,
+                "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<T, P>::ObserverPointer(T *t, const std::string &id)
   , id(id)
   , pointed_to_object_is_alive(false)
 {
-  static_assert(
-    std::is_base_of_v<EnableRefCountingByObserverPointer, T>,
-    "This class can only be used if the first template argument "
-    "is a class derived from 'EnableRefCountingByObserverPointer'.");
+  static_assert(std::is_base_of_v<EnableObserverPointer, T>,
+                "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<T, P>::ObserverPointer(
   , id(other.id)
   , pointed_to_object_is_alive(false)
 {
-  static_assert(
-    std::is_base_of_v<EnableRefCountingByObserverPointer, T>,
-    "This class can only be used if the first template argument "
-    "is a class derived from 'EnableRefCountingByObserverPointer'.");
+  static_assert(std::is_base_of_v<EnableObserverPointer, T>,
+                "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<T, P>::ObserverPointer(
   , id(other.id)
   , pointed_to_object_is_alive(false)
 {
-  static_assert(
-    std::is_base_of_v<EnableRefCountingByObserverPointer, T>,
-    "This class can only be used if the first template argument "
-    "is a class derived from 'EnableRefCountingByObserverPointer'.");
+  static_assert(std::is_base_of_v<EnableObserverPointer, T>,
+                "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<T, P>::ObserverPointer(
   , id(other.id)
   , pointed_to_object_is_alive(false)
 {
-  static_assert(
-    std::is_base_of_v<EnableRefCountingByObserverPointer, T>,
-    "This class can only be used if the first template argument "
-    "is a class derived from 'EnableRefCountingByObserverPointer'.");
+  static_assert(std::is_base_of_v<EnableObserverPointer, T>,
+                "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<T, P>::ObserverPointer(
 template <typename T, typename P>
 inline ObserverPointer<T, P>::~ObserverPointer()
 {
-  static_assert(
-    std::is_base_of_v<EnableRefCountingByObserverPointer, T>,
-    "This class can only be used if the first template argument "
-    "is a class derived from 'EnableRefCountingByObserverPointer'.");
+  static_assert(std::is_base_of_v<EnableObserverPointer, T>,
+                "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);
index 4767f6cd6aa3a1275e675e33e8ba6dba7d0e67f6..e504416c1e01ab785201bc90723bdcf0854e5bdd 100644 (file)
@@ -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:
   /**
index 2bdf932c803560e6e9cf5b2b192a7e48fbf357bf..78684558fb2dd0e2937de0cd396de937e09b11d2 100644 (file)
@@ -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<const EnableRefCountingByObserverPointer &>(*this);
+  ar &static_cast<const EnableObserverPointer &>(*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<EnableRefCountingByObserverPointer &>(*this);
+  ar &static_cast<EnableObserverPointer &>(*this);
 
   ar &*entries.get();
 
index dcbfd148b6511ea413302c14c29b0a7195b37cad..eff924ed45a2c05008d94d547610e2a0c32fda4e 100644 (file)
@@ -62,7 +62,7 @@ namespace Polynomials
    * TensorProductPolynomials class.
    */
   template <typename number>
-  class Polynomial : public EnableRefCountingByObserverPointer
+  class Polynomial : public EnableObserverPointer
   {
   public:
     /**
@@ -1031,7 +1031,7 @@ namespace Polynomials
   Polynomial<number>::serialize(Archive &ar, const unsigned int)
   {
     // forward to serialization function in the base class.
-    ar &static_cast<EnableRefCountingByObserverPointer &>(*this);
+    ar &static_cast<EnableObserverPointer &>(*this);
     ar &coefficients;
     ar &in_lagrange_product_form;
     ar &lagrange_support_points;
index ea7a4ca633b8d9d076052711dbc528792aa125e6..150b011015fb3a9e1886b4dbe647e304f2f4b4c4 100644 (file)
@@ -60,7 +60,7 @@ namespace Polynomials
    * @ingroup Polynomials
    */
   template <typename number>
-  class PiecewisePolynomial : public EnableRefCountingByObserverPointer
+  class PiecewisePolynomial : public EnableObserverPointer
   {
   public:
     /**
@@ -301,7 +301,7 @@ namespace Polynomials
   PiecewisePolynomial<number>::serialize(Archive &ar, const unsigned int)
   {
     // forward to serialization function in the base class.
-    ar &static_cast<EnableRefCountingByObserverPointer &>(*this);
+    ar &static_cast<EnableObserverPointer &>(*this);
     ar &polynomial;
     ar &n_intervals;
     ar &interval;
index a5343b7cfa0d212eba785c9791433ef9e9020c47..25fa249504ffb558ed94fff411b687ec182567da 100644 (file)
@@ -119,7 +119,7 @@ DEAL_II_NAMESPACE_OPEN
  * as "list of evaluation points".
  */
 template <int dim>
-class Quadrature : public EnableRefCountingByObserverPointer
+class Quadrature : public EnableObserverPointer
 {
 public:
   /**
@@ -545,7 +545,7 @@ Quadrature<dim>::serialize(Archive &ar, const unsigned int)
 {
   // forward to serialization
   // function in the base class.
-  ar &static_cast<EnableRefCountingByObserverPointer &>(*this);
+  ar &static_cast<EnableObserverPointer &>(*this);
 
   ar &quadrature_points &weights;
 }
index 97ed456a92bafaf5c922da9ba42f5be389eb23aa..5dd88393ffef67ed4d74059aa0954f54ef35bc1a 100644 (file)
@@ -60,7 +60,7 @@ DEAL_II_NAMESPACE_OPEN
  * for example, adopting a level-set approach to describe material behavior.
  */
 template <typename CellIteratorType, typename DataType>
-class CellDataStorage : public EnableRefCountingByObserverPointer
+class CellDataStorage : public EnableObserverPointer
 {
 public:
   /**
index 4aa281b424e2113a0ea9bc163e9a78656ba4d204..e9bda5dc471316f6f5afb25de74e98aa3aaf463c 100644 (file)
@@ -437,7 +437,7 @@ namespace internal
  * @ingroup data
  */
 template <int N, typename T>
-class TableBase : public EnableRefCountingByObserverPointer
+class TableBase : public EnableObserverPointer
 {
 public:
   using value_type = T;
@@ -2165,7 +2165,7 @@ TableBase<N, T>::TableBase(const TableIndices<N> &sizes,
 
 template <int N, typename T>
 TableBase<N, T>::TableBase(const TableBase<N, T> &src)
-  : EnableRefCountingByObserverPointer()
+  : EnableObserverPointer()
   , values(src.values)
   , table_size(src.table_size)
 {}
@@ -2185,7 +2185,7 @@ TableBase<N, T>::TableBase(const TableBase<N, T2> &src)
 
 template <int N, typename T>
 TableBase<N, T>::TableBase(TableBase<N, T> &&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 <class Archive>
 inline void
 TableBase<N, T>::serialize(Archive &ar, const unsigned int)
 {
-  ar &static_cast<EnableRefCountingByObserverPointer &>(*this);
+  ar &static_cast<EnableObserverPointer &>(*this);
 
   ar &values &table_size;
 }
@@ -2342,8 +2342,8 @@ template <int N, typename T>
 inline TableBase<N, T> &
 TableBase<N, T>::operator=(TableBase<N, T> &&m) noexcept
 {
-  static_cast<EnableRefCountingByObserverPointer &>(*this) =
-    std::move(static_cast<EnableRefCountingByObserverPointer &>(m));
+  static_cast<EnableObserverPointer &>(*this) =
+    std::move(static_cast<EnableObserverPointer &>(m));
   values       = std::move(m.values);
   table_size   = m.table_size;
   m.table_size = TableIndices<N>();
index 63d1f68db4fd2899459b3d9ec50cce7f8598b8d1..5a8b92764304b7532bbce6ddb34c4490ac923ab9 100644 (file)
@@ -54,7 +54,7 @@ DEAL_II_NAMESPACE_OPEN
 template <int rank, int dim, typename Number = double>
 class TensorFunction
   : public FunctionTime<typename numbers::NumberTraits<Number>::real_type>,
-    public EnableRefCountingByObserverPointer
+    public EnableObserverPointer
 {
 public:
   /**
index 811c57b96a149a9e3d64f3d63dcab94a6cefdbc4..db980b02b46782643b1756dd506f98558a6a3f37 100644 (file)
@@ -45,7 +45,7 @@ namespace RepartitioningPolicyTools
    * See the description of RepartitioningPolicyTools for more information.
    */
   template <int dim, int spacedim = dim>
-  class Base : public EnableRefCountingByObserverPointer
+  class Base : public EnableObserverPointer
   {
   public:
     /**
index b33ea27ab7ed4c052f355dbee1cc6c7bd968aa13..ab9c71432f2780e8cb3c30207d2cf7d92bdc2979 100644 (file)
@@ -545,8 +545,7 @@ namespace internal
        * for more information about artificial cells.
        */
       template <int dim, int spacedim = dim>
-      class TemporarilyRestoreSubdomainIds
-        : public EnableRefCountingByObserverPointer
+      class TemporarilyRestoreSubdomainIds : public EnableObserverPointer
       {
       public:
         /**
index 59b47fa1d979c940d9ed5c895e5bc7fc944041c3..81f22ef030af1de4b171dd60b0aaa5667d1257a2 100644 (file)
@@ -1113,8 +1113,7 @@ namespace parallel
      * The use of this class is demonstrated in step-75.
      */
     template <int dim, int spacedim = dim>
-    class TemporarilyMatchRefineFlags
-      : public EnableRefCountingByObserverPointer
+    class TemporarilyMatchRefineFlags : public EnableObserverPointer
     {
     public:
       /**
index ba6f869921a18222a56473b5cdb37096743a3117..ac02189781e11695c5f299d6ce95c2a0e4163c23 100644 (file)
@@ -91,7 +91,7 @@ class DoFHandler;
  *
  * @ingroup dofs
  */
-class BlockInfo : public EnableRefCountingByObserverPointer
+class BlockInfo : public EnableObserverPointer
 {
 public:
   /**
index c98c4d88e1ad3b6a7009cd0a02d70e79666b8779..e4aa5223b32410935615ce8cd5106f84bc0ac8a8 100644 (file)
@@ -313,7 +313,7 @@ namespace parallel
  */
 template <int dim, int spacedim = dim>
 DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<dim, spacedim>))
-class DoFHandler : public EnableRefCountingByObserverPointer
+class DoFHandler : public EnableObserverPointer
 {
   using ActiveSelector =
     dealii::internal::DoFHandlerImplementation::Iterators<dim, spacedim, false>;
index 10d82f66b46e46edf5f0db8e1275f0b7fd3bdb24..709750b4189a193f5a3953143e8df9267fc43bb8 100644 (file)
@@ -651,7 +651,7 @@ class FESystem;
  * @ingroup febase fe
  */
 template <int dim, int spacedim = dim>
-class FiniteElement : public EnableRefCountingByObserverPointer,
+class FiniteElement : public EnableObserverPointer,
                       public FiniteElementData<dim>
 {
 public:
index d6e407123b19176a00a89e05f132e5e9a4ba95b2..8aa5d6b690e60fbd5fadd3d5fecea82ef4be010b 100644 (file)
@@ -86,7 +86,7 @@ namespace FESeries
    * $ \bf k $ .
    */
   template <int dim, int spacedim = dim>
-  class Fourier : public EnableRefCountingByObserverPointer
+  class Fourier : public EnableObserverPointer
   {
   public:
     using CoefficientType = typename std::complex<double>;
@@ -256,7 +256,7 @@ namespace FESeries
    * $ \widetilde P_m(x) $ using tensor product rule.
    */
   template <int dim, int spacedim = dim>
-  class Legendre : public EnableRefCountingByObserverPointer
+  class Legendre : public EnableObserverPointer
   {
   public:
     using CoefficientType = double;
index c1c99d6b1aa7d0181bfbd6cc3df0e63a90763dec..e32dbe0697ccd12d4ca7c93dc78dbc778164f88b 100644 (file)
@@ -85,7 +85,7 @@ namespace FETools
    * FETools::add_fe_name() functions.
    */
   template <int dim, int spacedim = dim>
-  class FEFactoryBase : public EnableRefCountingByObserverPointer
+  class FEFactoryBase : public EnableObserverPointer
   {
   public:
     /**
index b138eaed04ead49f42f559bec8e38c8a40664546..505195ec1fcde9a2491b2f06ab2890fde5d2cde2 100644 (file)
@@ -1073,8 +1073,7 @@ namespace FETools
       template <int dim>
       void
       fill_no_codim_fe_names(
-        std::map<std::string,
-                 std::unique_ptr<const EnableRefCountingByObserverPointer>>
+        std::map<std::string, std::unique_ptr<const EnableObserverPointer>>
           &result)
       {
         result["FE_Q_Hierarchical"] =
@@ -1155,8 +1154,7 @@ namespace FETools
       template <int dim, int spacedim>
       void
       fill_codim_fe_names(
-        std::map<std::string,
-                 std::unique_ptr<const EnableRefCountingByObserverPointer>>
+        std::map<std::string, std::unique_ptr<const EnableObserverPointer>>
           &result)
       {
         result["FE_Bernstein"] =
@@ -1197,15 +1195,13 @@ namespace FETools
       // by the functions above.
       std::array<
         std::array<
-          std::map<std::string,
-                   std::unique_ptr<const EnableRefCountingByObserverPointer>>,
+          std::map<std::string, std::unique_ptr<const EnableObserverPointer>>,
           4>,
         4> inline fill_default_map()
       {
         std::array<
           std::array<
-            std::map<std::string,
-                     std::unique_ptr<const EnableRefCountingByObserverPointer>>,
+            std::map<std::string, std::unique_ptr<const EnableObserverPointer>>,
             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::string,
-                   std::unique_ptr<const EnableRefCountingByObserverPointer>>,
+          std::map<std::string, std::unique_ptr<const EnableObserverPointer>>,
           4>,
         4> &
       get_fe_name_map()
       {
         static std::array<
           std::array<
-            std::map<std::string,
-                     std::unique_ptr<const EnableRefCountingByObserverPointer>>,
+            std::map<std::string, std::unique_ptr<const EnableObserverPointer>>,
             4>,
           4>
           fe_name_map = fill_default_map();
@@ -2260,7 +2254,7 @@ namespace FETools
     std::unique_lock<std::shared_mutex> lock(
       internal::FEToolsAddFENameHelper::fe_name_map_lock);
     internal::FEToolsAddFENameHelper::get_fe_name_map()[dim][spacedim].emplace(
-      name, std::unique_ptr<const EnableRefCountingByObserverPointer>(factory));
+      name, std::unique_ptr<const EnableObserverPointer>(factory));
   }
 
 
@@ -2277,9 +2271,8 @@ namespace FETools
       std::unique_ptr<FiniteElement<dim, spacedim>>
       get_fe_by_name_ext(
         std::string &name,
-        const std::map<
-          std::string,
-          std::unique_ptr<const EnableRefCountingByObserverPointer>>
+        const std::map<std::string,
+                       std::unique_ptr<const EnableObserverPointer>>
           &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<dim, spacedim> *fef =
               dynamic_cast<const FETools::FEFactoryBase<dim, spacedim> *>(ptr);
@@ -2425,7 +2418,7 @@ namespace FETools
                 const std::pair<int, unsigned int> 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<dim, spacedim> *fef =
                   dynamic_cast<const FETools::FEFactoryBase<dim, spacedim> *>(
@@ -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<dim, spacedim> *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<dim, spacedim> *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<dim, spacedim> *fef =
                       dynamic_cast<
index 81f57f762b9862a2736b3693d981f4ce333aef52..b938fffc05987053ce0979ec1dc48f44732c00fb 100644 (file)
@@ -151,7 +151,7 @@ DEAL_II_NAMESPACE_OPEN
  * @ingroup feaccess
  */
 template <int dim, int spacedim>
-class FEValuesBase : public EnableRefCountingByObserverPointer
+class FEValuesBase : public EnableObserverPointer
 {
 public:
   /**
index 603328566732eb420341a1177f58efe339326ad8..3978d43e61d878eb08706e48334c9ec24d5e0e7b 100644 (file)
@@ -314,7 +314,7 @@ enum MappingKind
  * @ingroup mapping
  */
 template <int dim, int spacedim = dim>
-class Mapping : public EnableRefCountingByObserverPointer
+class Mapping : public EnableObserverPointer
 {
 public:
   /**
index c3ee8e0a47537d22fd97c9f2bc0dfe90fc5ff6bf..f1f21613c7ea7c4e55d0405db599d9e69c448a1f 100644 (file)
@@ -63,7 +63,7 @@ namespace GridTools
    * method mark_for_update() manually.
    */
   template <int dim, int spacedim = dim>
-  class Cache : public EnableRefCountingByObserverPointer
+  class Cache : public EnableObserverPointer
   {
   public:
     /**
index 4a8dca068cab0c8e9114e68c8027bf912fe97a03..b81789e16a54de26f84beffbbcb55089a4f3f7f3 100644 (file)
@@ -113,7 +113,7 @@ DEAL_II_NAMESPACE_OPEN
  */
 template <typename MeshType>
 DEAL_II_CXX20_REQUIRES(concepts::is_triangulation_or_dof_handler<MeshType>)
-class InterGridMap : public EnableRefCountingByObserverPointer
+class InterGridMap : public EnableObserverPointer
 {
 public:
   /**
index 68a519715b69e88f36dc5377672cdd34bc1926b0..644f1ae7d74916145d713ca3c41eff9b7c0704f8 100644 (file)
@@ -282,7 +282,7 @@ namespace Manifolds
  * @ingroup manifold
  */
 template <int dim, int spacedim = dim>
-class Manifold : public EnableRefCountingByObserverPointer
+class Manifold : public EnableObserverPointer
 {
 public:
   // explicitly check for sensible template arguments
index c2ad135c406f95909d3c2a2ac8d786a63d9489c0..bab4b37b6597906d8c3ad1e7da0524e1ac80683b 100644 (file)
@@ -1319,7 +1319,7 @@ namespace internal
  */
 template <int dim, int spacedim = dim>
 DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<dim, spacedim>))
-class Triangulation : public EnableRefCountingByObserverPointer
+class Triangulation : public EnableObserverPointer
 {
 private:
   /**
index fcd1cb939bfade287765594c4c17546908da6767..4234c32740fc8424561f56078371e2644a7d615d 100644 (file)
@@ -221,7 +221,7 @@ namespace hp
    * @ingroup hp hpcollection
    */
   template <typename T>
-  class Collection : public EnableRefCountingByObserverPointer
+  class Collection : public EnableObserverPointer
   {
   public:
     /**
index e4d86ac99c3eb7920cfa7a2a8baf78ba221a5672..195251ef831a082d807364964061a5d05480596e 100644 (file)
@@ -64,7 +64,7 @@ namespace hp
    * @ingroup hp
    */
   template <int dim, int q_dim, typename FEValuesType>
-  class FEValuesBase : public EnableRefCountingByObserverPointer
+  class FEValuesBase : public EnableObserverPointer
   {
   public:
     /**
index 4a2f6614beceabd9ebc0d0a9132b9c9acdbbb16c..43d280257680493d36adec0002698af194bcd513 100644 (file)
@@ -503,7 +503,7 @@ namespace internal
  * @ingroup constraints
  */
 template <typename number = double>
-class AffineConstraints : public EnableRefCountingByObserverPointer
+class AffineConstraints : public EnableObserverPointer
 {
 public:
   /**
@@ -2370,7 +2370,7 @@ inline AffineConstraints<number>::AffineConstraints(
 template <typename number>
 inline AffineConstraints<number>::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)
index 97c3c0da26b5ffaa6623760ffd8df1303e10359f..0a23be77bfd4d58ac097519865092767820fd9e7 100644 (file)
@@ -163,7 +163,7 @@ dseupd_(int          *rvec,
  * @ref step_36 "step-36"
  * for an example.
  */
-class ArpackSolver : public EnableRefCountingByObserverPointer
+class ArpackSolver : public EnableObserverPointer
 {
 public:
   /**
index 6eae92a4d14ab1cb4e7a152bdff466d87028ae83..d7ebf02f1637db173eaec9359b0110d06a14abc5 100644 (file)
@@ -56,7 +56,7 @@ DEAL_II_NAMESPACE_OPEN
  * @see
  * @ref GlossBlockLA "Block (linear algebra)"
  */
-class BlockIndices : public EnableRefCountingByObserverPointer
+class BlockIndices : public EnableObserverPointer
 {
 public:
   /**
index 86601ea0f6429f44a32a2ff232faf0206348836f..d47f93a25be2d98b176c414db8c601af8a67e076 100644 (file)
@@ -346,7 +346,7 @@ namespace BlockMatrixIterators
  * @ref GlossBlockLA "Block (linear algebra)"
  */
 template <typename MatrixType>
-class BlockMatrixBase : public EnableRefCountingByObserverPointer
+class BlockMatrixBase : public EnableObserverPointer
 {
 public:
   /**
index d0be4a1d0de9878095be3f9ca45c08a8e38c4c7e..1d7a7aa52e4dc8439a90d3da7614cf8e2208cccb 100644 (file)
@@ -57,7 +57,7 @@ class BlockVector;
  * @ref GlossBlockLA "Block (linear algebra)"
  */
 template <typename Number>
-class BlockSparseMatrixEZ : public EnableRefCountingByObserverPointer
+class BlockSparseMatrixEZ : public EnableObserverPointer
 {
 public:
   /**
index 7467ff1330b83ac76658ed858e14d69f28e404a7..6b6703f7f79231268035c50b288950eca7393b03 100644 (file)
@@ -82,7 +82,7 @@ BlockSparseMatrixEZ<number>::operator=(const double d)
 template <typename number>
 BlockSparseMatrixEZ<number>::BlockSparseMatrixEZ(
   const BlockSparseMatrixEZ<number> &m)
-  : EnableRefCountingByObserverPointer(m)
+  : EnableObserverPointer(m)
   , row_indices(m.row_indices)
   , column_indices(m.column_indices)
   , blocks(m.blocks)
index 2e912f16ebb9e74d63a6659ed323ee0f09637483..a4c848d9df6f56e106a9fde1860ad21361d8b422 100644 (file)
@@ -438,7 +438,7 @@ namespace internal
  * @ref GlossBlockLA "Block (linear algebra)"
  */
 template <typename VectorType>
-class BlockVectorBase : public EnableRefCountingByObserverPointer,
+class BlockVectorBase : public EnableObserverPointer,
                         public ReadVector<typename VectorType::value_type>
 {
 public:
index 6d8ab9cde127d798da97c100f8b34017eef943d0..62d717709312f7610d3a20598e401138cd4ac455 100644 (file)
@@ -445,7 +445,7 @@ DEAL_II_NAMESPACE_OPEN
  * in the manual).
  */
 template <typename number>
-class ChunkSparseMatrix : public virtual EnableRefCountingByObserverPointer
+class ChunkSparseMatrix : public virtual EnableObserverPointer
 {
 public:
   /**
index 960b6f4fa1a433bcdc48a375a288003e6ce0d5c6..4c9ffdd10703dad3933066cead693f4f5e0d5d9c 100644 (file)
@@ -279,7 +279,7 @@ ChunkSparseMatrix<number>::ChunkSparseMatrix()
 
 template <typename number>
 ChunkSparseMatrix<number>::ChunkSparseMatrix(const ChunkSparseMatrix &m)
-  : EnableRefCountingByObserverPointer(m)
+  : EnableObserverPointer(m)
   , cols(nullptr, "ChunkSparseMatrix")
   , val(nullptr)
   , max_len(0)
index 6391260d646fe9ba309bdc2ee2d767c421fd6d23..ac78820adb269365ea5f0439f121e24fbe6143b9 100644 (file)
@@ -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:
   /**
index e1a8daab0ff6db484d099d136ae518eed5df824f..03e49b873ee1a66de8ef846154c76a1c60d26c12 100644 (file)
@@ -58,7 +58,7 @@ namespace LinearAlgebra
  * @endcode
  */
 template <typename VectorType = Vector<double>>
-class DiagonalMatrix : public EnableRefCountingByObserverPointer
+class DiagonalMatrix : public EnableObserverPointer
 {
 public:
   using value_type = typename VectorType::value_type;
index 1ad5ce92979fff72e7acc9a451a57f602988befe..9570c17748e1855393d7c6282cab71fbc8f68e68 100644 (file)
@@ -247,7 +247,7 @@ namespace LinearAlgebra
      */
     template <typename Number, typename MemorySpace = MemorySpace::Host>
     class Vector : public ::dealii::ReadVector<Number>,
-                   public EnableRefCountingByObserverPointer
+                   public EnableObserverPointer
     {
     public:
       using memory_space    = MemorySpace;
index 1b2799df6fa72a320a47a67ec394919d0b9ca73d..1d01fb518ccdd47620b0e75e3e295e7da3d8a958 100644 (file)
@@ -730,7 +730,7 @@ namespace LinearAlgebra
     template <typename Number, typename MemorySpaceType>
     Vector<Number, MemorySpaceType>::Vector(
       const Vector<Number, MemorySpaceType> &v)
-      : EnableRefCountingByObserverPointer()
+      : EnableObserverPointer()
       , allocated_size(0)
       , vector_is_ghosted(false)
       , comm_sm(MPI_COMM_SELF)
@@ -749,8 +749,8 @@ namespace LinearAlgebra
       Vector<Number, MemorySpaceType> &&v)
       : Vector()
     {
-      static_cast<EnableRefCountingByObserverPointer &>(*this) =
-        static_cast<EnableRefCountingByObserverPointer &&>(v);
+      static_cast<EnableObserverPointer &>(*this) =
+        static_cast<EnableObserverPointer &&>(v);
       this->swap(v);
     }
 
@@ -1428,8 +1428,8 @@ namespace LinearAlgebra
     Vector<Number, MemorySpaceType>::operator=( // NOLINT
       Vector<Number, MemorySpaceType> &&v)
     {
-      static_cast<EnableRefCountingByObserverPointer &>(*this) =
-        static_cast<EnableRefCountingByObserverPointer &&>(v);
+      static_cast<EnableObserverPointer &>(*this) =
+        static_cast<EnableObserverPointer &&>(v);
       this->swap(v);
       return *this;
     }
index 05a273ca4b0293176465ae62c92de7000b9fd9fd..aa15249f94027cd59f610951182fcc2e15c40b54 100644 (file)
@@ -1007,7 +1007,7 @@ private:
  * @ingroup Preconditioners
  */
 template <typename number>
-class PreconditionLU : public EnableRefCountingByObserverPointer
+class PreconditionLU : public EnableObserverPointer
 {
 public:
   void
index 748dd7e0f4e56501d2eaf5e851f5d3d3f753944b..0f988f9ff4e8d9999224ad9f7d0491a8d58606e8 100644 (file)
@@ -89,7 +89,7 @@ namespace internal
  * @ref GlossBlockLA "Block (linear algebra)"
  */
 template <typename MatrixType>
-class MatrixBlock : public EnableRefCountingByObserverPointer
+class MatrixBlock : public EnableObserverPointer
 {
 public:
   /**
@@ -419,7 +419,7 @@ public:
  * @ingroup vector_valued
  */
 template <typename MatrixType>
-class MGMatrixBlockVector : public EnableRefCountingByObserverPointer
+class MGMatrixBlockVector : public EnableObserverPointer
 {
 public:
   /**
index ee7408274d5f9ed851d722f16f8639452a3c7fe7..bf37e51a3f82a3da84b81d941fe6fc4137f2cac9 100644 (file)
@@ -207,7 +207,7 @@ extern "C"
  * PARPACK manual.
  */
 template <typename VectorType>
-class PArpackSolver : public EnableRefCountingByObserverPointer
+class PArpackSolver : public EnableObserverPointer
 {
 public:
   /**
index 66bfed4e466c09d2268bf23105b2c7a06af06662..190582715bb163ba627ef1aada185eb0e872093a 100644 (file)
@@ -291,7 +291,7 @@ namespace PETScWrappers
    * @ingroup PETScWrappers
    * @ingroup Matrix1
    */
-  class MatrixBase : public EnableRefCountingByObserverPointer
+  class MatrixBase : public EnableObserverPointer
   {
   public:
     /**
index 556e0caae341d852f010f1f949fe6443fc6993fb..969fe3ea3fd404ee6532aac329f0ad2eb9f01a79 100644 (file)
@@ -56,7 +56,7 @@ namespace PETScWrappers
    *
    * @ingroup PETScWrappers
    */
-  class PreconditionBase : public EnableRefCountingByObserverPointer
+  class PreconditionBase : public EnableObserverPointer
   {
   public:
     /**
index a2afbbf872e9fbae74d2c4095b70fb441d1d095f..324de0ba51eb0d0fe931aa6dd912f046cb5c7e4e 100644 (file)
@@ -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);
    *    ...
index 9ac5f5b561ba078a4e4693b825f4e22473637001..d7bce504d1bc5491cbf0828818b3d1881cc64caa 100644 (file)
@@ -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);
    *    ...
index 1ecd48c048d92ce71feaedc969f47b9f2b415535..5798b44edcad167b4d5ce3aad951dcb45d442962 100644 (file)
@@ -250,7 +250,7 @@ namespace PETScWrappers
    * @ingroup PETScWrappers
    */
   class VectorBase : public ReadVector<PetscScalar>,
-                     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<const EnableRefCountingByObserverPointer &>(*this);
+    ar &static_cast<const EnableObserverPointer &>(*this);
     ar &size();
     ar &local_range();
 
@@ -1344,7 +1344,7 @@ namespace PETScWrappers
   inline void
   VectorBase::load(Archive &ar, const unsigned int)
   {
-    ar &static_cast<EnableRefCountingByObserverPointer &>(*this);
+    ar &static_cast<EnableObserverPointer &>(*this);
 
     size_type                       size = 0;
     std::pair<size_type, size_type> local_range;
index 1078656c4ff41620e8494a4a364b2b410e3a8162..6682077948f809941d47ef1b6b091cc6560a60c3 100644 (file)
@@ -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 MatrixType = SparseMatrix<double>,
           typename VectorType = Vector<double>>
-class PreconditionUseMatrix : public EnableRefCountingByObserverPointer
+class PreconditionUseMatrix : public EnableObserverPointer
 {
 public:
   /**
@@ -562,7 +562,7 @@ private:
  */
 template <typename MatrixType         = SparseMatrix<double>,
           typename PreconditionerType = IdentityMatrix>
-class PreconditionRelaxation : public EnableRefCountingByObserverPointer
+class PreconditionRelaxation : public EnableObserverPointer
 {
 public:
   /**
@@ -2026,7 +2026,7 @@ public:
  * <h4>Requirements on the templated classes</h4>
  *
  * 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 MatrixType         = SparseMatrix<double>,
           typename VectorType         = Vector<double>,
           typename PreconditionerType = DiagonalMatrix<VectorType>>
-class PreconditionChebyshev : public EnableRefCountingByObserverPointer
+class PreconditionChebyshev : public EnableObserverPointer
 {
 public:
   /**
index 6f003844325ddeb755821fb07915a8e26ce42bf1..138bf6846f303ffc7578cba26700db58b07d5f8b 100644 (file)
@@ -78,7 +78,7 @@ DEAL_II_NAMESPACE_OPEN
  */
 template <typename MatrixType,
           typename inverse_type = typename MatrixType::value_type>
-class PreconditionBlock : public virtual EnableRefCountingByObserverPointer,
+class PreconditionBlock : public virtual EnableObserverPointer,
                           protected PreconditionBlockBase<inverse_type>
 {
 private:
@@ -376,7 +376,7 @@ protected:
 template <typename MatrixType,
           typename inverse_type = typename MatrixType::value_type>
 class PreconditionBlockJacobi
-  : public virtual EnableRefCountingByObserverPointer,
+  : public virtual EnableObserverPointer,
     private PreconditionBlock<MatrixType, inverse_type>
 {
 private:
@@ -653,7 +653,7 @@ private:
 template <typename MatrixType,
           typename inverse_type = typename MatrixType::value_type>
 class PreconditionBlockSOR
-  : public virtual EnableRefCountingByObserverPointer,
+  : public virtual EnableObserverPointer,
     protected PreconditionBlock<MatrixType, inverse_type>
 {
 public:
@@ -810,7 +810,7 @@ protected:
 template <typename MatrixType,
           typename inverse_type = typename MatrixType::value_type>
 class PreconditionBlockSSOR
-  : public virtual EnableRefCountingByObserverPointer,
+  : public virtual EnableObserverPointer,
     private PreconditionBlockSOR<MatrixType, inverse_type>
 {
 public:
index ccb982aae24ae69ff74f54fe7ce1a67454bac9e8..e6c7e86a0e729b2bbf13f1e98e347285866404fc 100644 (file)
@@ -97,7 +97,7 @@ class SparseMatrix;
  */
 template <typename MatrixType = SparseMatrix<double>,
           typename VectorType = dealii::Vector<double>>
-class PreconditionSelector : public EnableRefCountingByObserverPointer
+class PreconditionSelector : public EnableObserverPointer
 {
 public:
   /**
index b49fbcc7e54c328cee837af1b82e8eddfe7a5a31..a6cd5b885ebaf9d53b08f4128d8a17247d432af9 100644 (file)
@@ -123,7 +123,7 @@ namespace LinearAlgebra
    * get the first index of the largest range.
    */
   template <typename Number>
-  class ReadWriteVector : public EnableRefCountingByObserverPointer,
+  class ReadWriteVector : public EnableObserverPointer,
                           public ReadVector<Number>
   {
   public:
@@ -847,7 +847,7 @@ namespace LinearAlgebra
   template <typename Number>
   inline ReadWriteVector<Number>::ReadWriteVector(
     const ReadWriteVector<Number> &v)
-    : EnableRefCountingByObserverPointer()
+    : EnableObserverPointer()
   {
     this->operator=(v);
   }
index 3be4b073c8bf283bce225c57b11a116527172ff6..76987dfc76a9fee20025f7b8620df6aa00192b9d 100644 (file)
@@ -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 <typename MatrixType,
           typename InverseNumberType = typename MatrixType::value_type,
           typename VectorType        = Vector<double>>
 class RelaxationBlockJacobi
-  : public virtual EnableRefCountingByObserverPointer,
+  : public virtual EnableObserverPointer,
     protected RelaxationBlock<MatrixType, InverseNumberType, VectorType>
 {
 public:
@@ -379,7 +379,7 @@ template <typename MatrixType,
           typename InverseNumberType = typename MatrixType::value_type,
           typename VectorType        = Vector<double>>
 class RelaxationBlockSOR
-  : public virtual EnableRefCountingByObserverPointer,
+  : public virtual EnableObserverPointer,
     protected RelaxationBlock<MatrixType, InverseNumberType, VectorType>
 {
 public:
@@ -475,7 +475,7 @@ template <typename MatrixType,
           typename InverseNumberType = typename MatrixType::value_type,
           typename VectorType        = Vector<double>>
 class RelaxationBlockSSOR
-  : public virtual EnableRefCountingByObserverPointer,
+  : public virtual EnableObserverPointer,
     protected RelaxationBlock<MatrixType, InverseNumberType, VectorType>
 {
 public:
index 21f8b7a7b38b5e0c549203975d8fd25e0c42d351..285499d75543af3ce61d7f19d80389e261178794 100644 (file)
@@ -338,7 +338,7 @@ class Vector;
  */
 template <typename VectorType = Vector<double>>
 DEAL_II_CXX20_REQUIRES(concepts::is_vector_space_vector<VectorType>)
-class SolverBase : public EnableRefCountingByObserverPointer
+class SolverBase : public EnableObserverPointer
 {
 public:
   /**
index 79214b2277c405ffed3bbb1cb7aee5bd5f2b7255..01308b97446b06a75dec30267b6d07b0c3375361 100644 (file)
@@ -63,7 +63,7 @@ class ParameterHandler;
  * number of iterations.
  * </ul>
  */
-class SolverControl : public EnableRefCountingByObserverPointer
+class SolverControl : public EnableObserverPointer
 {
 public:
   /**
index 4f939d6ec5a861dae785edad1824dc7035f665b4..5601e5e6806fb9706e771895e245aed88bfc5f9d 100644 (file)
@@ -89,7 +89,7 @@ DEAL_II_NAMESPACE_OPEN
  */
 template <typename VectorType = Vector<double>>
 DEAL_II_CXX20_REQUIRES(concepts::is_vector_space_vector<VectorType>)
-class SolverSelector : public EnableRefCountingByObserverPointer
+class SolverSelector : public EnableObserverPointer
 {
 public:
   /**
index 51ae84fa157533438e5f213618c6e6d833d0a7a6..9e345654075d5b9359a295ff1a469294bbaf4179 100644 (file)
@@ -104,7 +104,7 @@ DEAL_II_NAMESPACE_OPEN
  */
 template <typename number>
 class SparseLUDecomposition : protected SparseMatrix<number>,
-                              public virtual EnableRefCountingByObserverPointer
+                              public virtual EnableObserverPointer
 {
 protected:
   /**
index 4ad3c80ce3712911f7f6fe3b15a09549ef562f9b..29e9b1a91794ed0d2b51bdf0ef26e40c1c72fe41 100644 (file)
@@ -88,7 +88,7 @@ namespace types
  *
  * @ingroup Solvers Preconditioners
  */
-class SparseDirectUMFPACK : public EnableRefCountingByObserverPointer
+class SparseDirectUMFPACK : public EnableObserverPointer
 {
 public:
   /**
index 91b230357a94dcfc7acf066262b473aefbb56c4a..6d7ac5d93fa0356825f99936f181758f0bd27cb3 100644 (file)
@@ -516,7 +516,7 @@ DEAL_II_NAMESPACE_OPEN
  * @ingroup Matrix1
  */
 template <typename number>
-class SparseMatrix : public virtual EnableRefCountingByObserverPointer
+class SparseMatrix : public virtual EnableObserverPointer
 {
 public:
   /**
index d1467be7a810b3803a404d05ca5bab552a31cc6a..2af8a963a4430e89113e82477b0f2b8925199776 100644 (file)
@@ -55,7 +55,7 @@ SparseMatrix<number>::SparseMatrix()
 
 template <typename number>
 SparseMatrix<number>::SparseMatrix(const SparseMatrix &m)
-  : EnableRefCountingByObserverPointer(m)
+  : EnableObserverPointer(m)
   , cols(nullptr, "SparseMatrix")
   , val(nullptr)
   , max_len(0)
@@ -72,7 +72,7 @@ SparseMatrix<number>::SparseMatrix(const SparseMatrix &m)
 
 template <typename number>
 SparseMatrix<number>::SparseMatrix(SparseMatrix<number> &&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)
index 068a9ab94087bea5460f59da378f14971eb3b6bb..6d6d9a3232be2cdfd4ec71b37651eec6c9c055a6 100644 (file)
@@ -100,7 +100,7 @@ class FullMatrix;
  *   where "EZ" is pronounced the same way as the word "easy".
  */
 template <typename number>
-class SparseMatrixEZ : public EnableRefCountingByObserverPointer
+class SparseMatrixEZ : public EnableObserverPointer
 {
 public:
   /**
index f63068d73ba7d4e5c65cb4407573a304a3b9a048..5fe550071c24b9b7c85bcee03436123d1fa4d325 100644 (file)
@@ -40,7 +40,7 @@ SparseMatrixEZ<number>::SparseMatrixEZ()
 
 template <typename number>
 SparseMatrixEZ<number>::SparseMatrixEZ(const SparseMatrixEZ<number> &m)
-  : EnableRefCountingByObserverPointer(m)
+  : EnableObserverPointer(m)
   , n_columns(0)
   , increment(m.increment)
   , saved_default_row_length(m.saved_default_row_length)
index 251c6d9d359a105e0d53013134153160a5a20cec..39e11353ef3164f3657a0063c5ab3c0665de66d8 100644 (file)
@@ -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<const EnableRefCountingByObserverPointer>(
-      *this);
+  ar &boost::serialization::base_object<const EnableObserverPointer>(*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<EnableRefCountingByObserverPointer>(
-    *this);
+  ar &boost::serialization::base_object<EnableObserverPointer>(*this);
 
   ar &max_dim &rows &cols &max_vec_len &max_row_length &compressed;
 
index aa4a73b18252524b597767425722e420a5c31eda..75effad791a1cf1a2f23ca2fbf9f00a73ccbcbf1 100644 (file)
@@ -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:
   /**
index 96991c9948ead4a1458aa2b010b80472edd06d7a..78212ddb0f0f3c58cff35c08e9f5b1c6a4354136 100644 (file)
@@ -223,7 +223,7 @@ namespace LinearAlgebra
      * @ingroup Vectors
      */
     class Vector : public ReadVector<VectorTraits::value_type>,
-                   public EnableRefCountingByObserverPointer
+                   public EnableObserverPointer
     {
     public:
       using value_type      = VectorTraits::value_type;
index a0e3f085bbbc2b394266e96a36cd45fd86b1db50..7e0f2344a95d8a5f11086bc891fc9e5a4b309820 100644 (file)
@@ -73,7 +73,7 @@ namespace TrilinosWrappers
    * @ingroup TrilinosWrappers
    * @ingroup Preconditioners
    */
-  class PreconditionBase : public EnableRefCountingByObserverPointer
+  class PreconditionBase : public EnableObserverPointer
   {
   public:
     /**
index cc51c6826409abc9d7bc18e3c6c3116afad2f33a..ce27cac78a178cf1f91ad4420c57fa542efdb6a0 100644 (file)
@@ -482,7 +482,7 @@ namespace TrilinosWrappers
    *
    * @ingroup TrilinosWrappers
    */
-  class SolverDirect : public EnableRefCountingByObserverPointer
+  class SolverDirect : public EnableObserverPointer
   {
   public:
     /**
index d56ad06519a6209e5151bbcdc83486c60b8da06b..8e05a1433ce82fa35b23463a9614ea040117ae91 100644 (file)
@@ -546,7 +546,7 @@ namespace TrilinosWrappers
    * @ingroup TrilinosWrappers
    * @ingroup Matrix1
    */
-  class SparseMatrix : public EnableRefCountingByObserverPointer
+  class SparseMatrix : public EnableObserverPointer
   {
   public:
     /**
index af702dfd97d85b085e4abd8134c3c94127a91ca1..19d4721429e50e90014a83103edfaa72ef370aa1 100644 (file)
@@ -53,7 +53,7 @@ namespace LinearAlgebra
      * @ingroup Preconditioners
      */
     template <typename Number, typename MemorySpace = dealii::MemorySpace::Host>
-    class PreconditionBase : public EnableRefCountingByObserverPointer
+    class PreconditionBase : public EnableObserverPointer
     {
     public:
       /**
index 791138c5722e9ff0b211c31194f13d75d2d6c04b..1e6af0de7c3880c0e4017b87ae6796416db323e8 100644 (file)
@@ -107,7 +107,7 @@ namespace LinearAlgebra
      * the matrix, you must call SparseMatrix::compress() again.
      */
     template <typename Number, typename MemorySpace = dealii::MemorySpace::Host>
-    class SparseMatrix : public EnableRefCountingByObserverPointer
+    class SparseMatrix : public EnableObserverPointer
     {
     public:
       /**
index 13d4c819e6e3fd632237b8101159d8a51cc557e6..f5e5c89d92e1390ae11a69b5b3e1a90eaa31c23b 100644 (file)
@@ -285,8 +285,7 @@ namespace LinearAlgebra
      * @ingroup Vectors
      */
     template <typename Number, typename MemorySpace = dealii::MemorySpace::Host>
-    class Vector : public ReadVector<Number>,
-                   public EnableRefCountingByObserverPointer
+    class Vector : public ReadVector<Number>, public EnableObserverPointer
     {
     public:
       /**
index 6eec9b7dc574c7559567578ff224fe700329398d..908d31e0c906bf2435c9013cde4a61b04e582624 100644 (file)
@@ -78,7 +78,7 @@ namespace LinearAlgebra
 
     template <typename Number, typename MemorySpace>
     Vector<Number, MemorySpace>::Vector()
-      : EnableRefCountingByObserverPointer()
+      : EnableObserverPointer()
       , compressed(true)
       , has_ghost(false)
       , vector(Utilities::Trilinos::internal::make_rcp<
@@ -91,7 +91,7 @@ namespace LinearAlgebra
 
     template <typename Number, typename MemorySpace>
     Vector<Number, MemorySpace>::Vector(const Vector<Number, MemorySpace> &V)
-      : EnableRefCountingByObserverPointer()
+      : EnableObserverPointer()
       , compressed(V.compressed)
       , has_ghost(V.has_ghost)
       , vector(Utilities::Trilinos::internal::make_rcp<
@@ -109,7 +109,7 @@ namespace LinearAlgebra
     template <typename Number, typename MemorySpace>
     Vector<Number, MemorySpace>::Vector(
       const Teuchos::RCP<TpetraTypes::VectorType<Number, MemorySpace>> V)
-      : EnableRefCountingByObserverPointer()
+      : EnableObserverPointer()
       , compressed(true)
       , has_ghost(V->getMap()->isOneToOne() == false)
       , vector(V)
@@ -120,7 +120,7 @@ namespace LinearAlgebra
     template <typename Number, typename MemorySpace>
     Vector<Number, MemorySpace>::Vector(const IndexSet &parallel_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)
         {
index e38a07dd13451f173f288bf3cc4c11b24385fedb..459b6d3b38f7aa313d7a5187bb98bc583bd043f3 100644 (file)
@@ -401,7 +401,7 @@ namespace TrilinosWrappers
      * @ingroup TrilinosWrappers
      * @ingroup Vectors
      */
-    class Vector : public EnableRefCountingByObserverPointer,
+    class Vector : public EnableObserverPointer,
                    public ReadVector<TrilinosScalar>
     {
     public:
index 7ec3e32c071d7db356b5ef581ecd27973e315b51..7723b3f8fbeb67c865bd37987d3e12416be439d4 100644 (file)
@@ -116,8 +116,7 @@ namespace parallel
  * in the manual).
  */
 template <typename Number>
-class Vector : public EnableRefCountingByObserverPointer,
-               public ReadVector<Number>
+class Vector : public EnableObserverPointer, public ReadVector<Number>
 {
 public:
   /**
@@ -1481,7 +1480,7 @@ inline void
 Vector<Number>::save(Archive &ar, const unsigned int) const
 {
   // forward to serialization function in the base class.
-  ar &static_cast<const EnableRefCountingByObserverPointer &>(*this);
+  ar &static_cast<const EnableObserverPointer &>(*this);
   ar &values;
 }
 
@@ -1493,7 +1492,7 @@ inline void
 Vector<Number>::load(Archive &ar, const unsigned int)
 {
   // the load stuff again from the archive
-  ar &static_cast<EnableRefCountingByObserverPointer &>(*this);
+  ar &static_cast<EnableObserverPointer &>(*this);
   ar &values;
   maybe_reset_thread_partitioner();
 }
index a32065f2fd1d92685878a48f7fb6e472152f954f..f48e063a03ff9a947f060cf7ea6ad43662707663 100644 (file)
@@ -52,7 +52,7 @@ DEAL_II_NAMESPACE_OPEN
 
 template <typename Number>
 Vector<Number>::Vector(const Vector<Number> &v)
-  : EnableRefCountingByObserverPointer()
+  : EnableObserverPointer()
 {
   *this = v;
 }
index 2545107c4c403e198701605da64acfd9626aa108..45fe9d3a3a59f8e39d07d41d7f619c2d73f49290 100644 (file)
@@ -101,7 +101,7 @@ DEAL_II_NAMESPACE_OPEN
  * <i>always</i> returned.
  */
 template <typename VectorType = dealii::Vector<double>>
-class VectorMemory : public EnableRefCountingByObserverPointer
+class VectorMemory : public EnableObserverPointer
 {
 public:
   /**
index f54d0891cf7d9e5d785544db88eccda3d10b2d94..8ffcbcfec345061969822fd6df18c7c00b0d8bc7 100644 (file)
@@ -283,7 +283,7 @@ struct FERemoteCommunicationObjectTwoLevel
  * A class to fill the fields in PrecomputedEvaluationData.
  */
 template <int dim>
-class FERemoteEvaluationCommunicator : public EnableRefCountingByObserverPointer
+class FERemoteEvaluationCommunicator : public EnableObserverPointer
 {
 public:
   /**
index ca7c7286d6482d756a67322423231d8db1e25501..63df0bb8e37b9580c846b40f01cc98d81f4d0311 100644 (file)
@@ -109,7 +109,7 @@ DEAL_II_NAMESPACE_OPEN
 template <int dim,
           typename Number              = double,
           typename VectorizedArrayType = VectorizedArray<Number>>
-class MatrixFree : public EnableRefCountingByObserverPointer
+class MatrixFree : public EnableObserverPointer
 {
   static_assert(
     std::is_same_v<Number, typename VectorizedArrayType::value_type>,
index 0a80f23e393705676626e4018585ef89093d02ab..2ed4f1a17d12b5a5aa7f74627dc027cee04b7240 100644 (file)
@@ -77,7 +77,7 @@ DEAL_II_NAMESPACE_OPEN
 
 template <int dim, typename Number, typename VectorizedArrayType>
 MatrixFree<dim, Number, VectorizedArrayType>::MatrixFree()
-  : EnableRefCountingByObserverPointer()
+  : EnableObserverPointer()
   , indices_are_initialized(false)
   , mapping_is_initialized(false)
   , mg_level(numbers::invalid_unsigned_int)
@@ -88,7 +88,7 @@ MatrixFree<dim, Number, VectorizedArrayType>::MatrixFree()
 template <int dim, typename Number, typename VectorizedArrayType>
 MatrixFree<dim, Number, VectorizedArrayType>::MatrixFree(
   const MatrixFree<dim, Number, VectorizedArrayType> &other)
-  : EnableRefCountingByObserverPointer()
+  : EnableObserverPointer()
 {
   copy_from(other);
 }
index e5b6d7fab372e5d5436e2ffd98d431366256de70..83453a8c009bc63f3d0a13da885e375de8beadcd 100644 (file)
@@ -184,7 +184,7 @@ namespace MatrixFreeOperators
             typename VectorType = LinearAlgebra::distributed::Vector<double>,
             typename VectorizedArrayType =
               VectorizedArray<typename VectorType::value_type>>
-  class Base : public EnableRefCountingByObserverPointer
+  class Base : public EnableObserverPointer
   {
   public:
     /**
@@ -534,7 +534,7 @@ namespace MatrixFreeOperators
    * prolongation phase.
    */
   template <typename OperatorType>
-  class MGInterfaceOperator : public EnableRefCountingByObserverPointer
+  class MGInterfaceOperator : public EnableObserverPointer
   {
   public:
     /**
@@ -1215,7 +1215,7 @@ namespace MatrixFreeOperators
   //----------------- Base operator -----------------------------
   template <int dim, typename VectorType, typename VectorizedArrayType>
   Base<dim, VectorType, VectorizedArrayType>::Base()
-    : EnableRefCountingByObserverPointer()
+    : EnableObserverPointer()
     , have_interface_matrices(false)
   {}
 
@@ -1805,7 +1805,7 @@ namespace MatrixFreeOperators
 
   template <typename OperatorType>
   MGInterfaceOperator<OperatorType>::MGInterfaceOperator()
-    : EnableRefCountingByObserverPointer()
+    : EnableObserverPointer()
     , mf_base_operator(nullptr)
   {}
 
index 6a20de94f74c50b21de09aefd4738045833263e0..8dcfa4e0eefc3630b51eff677de648c097f95498 100644 (file)
@@ -86,7 +86,7 @@ namespace Portable
    * @note Only float and double are supported.
    */
   template <int dim, typename Number = double>
-  class MatrixFree : public EnableRefCountingByObserverPointer
+  class MatrixFree : public EnableObserverPointer
   {
   public:
     using jacobian_type = Tensor<2, dim, Tensor<1, dim, Number>>;
index 75c544944fc33bfee20bc010ff04d11b235ccbfd..31e4864c55d138f4a981bc1af86091a757e90f70 100644 (file)
@@ -56,8 +56,7 @@ namespace MeshWorker
    * @ingroup MeshWorker
    */
   template <int dim, int spacedim = dim, typename number = double>
-  class DEAL_II_DEPRECATED LocalIntegrator
-    : public EnableRefCountingByObserverPointer
+  class DEAL_II_DEPRECATED LocalIntegrator : public EnableObserverPointer
   {
   public:
     /**
index 2f8dc0bc77fa09018c0ddf36f1e8be40cfb04fc2..e4be3f96d8e4dc355fad036ad12657eda9a008d2 100644 (file)
@@ -44,7 +44,7 @@ namespace MeshWorker
    *
    * @ingroup MeshWorker
    */
-  class VectorSelector : public EnableRefCountingByObserverPointer
+  class VectorSelector : public EnableObserverPointer
   {
   public:
     /**
index 711849aa4636c39a5006bcca8c8496978f21b144..21f21357fdfffd5fa1ab3eaf3e6bcefde9e1d247 100644 (file)
@@ -44,7 +44,7 @@ DEAL_II_NAMESPACE_OPEN
  * of matrices, will be sufficient for applications.
  */
 template <typename VectorType>
-class MGMatrixBase : public EnableRefCountingByObserverPointer
+class MGMatrixBase : public EnableObserverPointer
 {
 public:
   /*
@@ -104,7 +104,7 @@ public:
  * will be done by derived classes.
  */
 template <typename VectorType>
-class MGCoarseGridBase : public EnableRefCountingByObserverPointer
+class MGCoarseGridBase : public EnableObserverPointer
 {
 public:
   /**
@@ -168,7 +168,7 @@ public:
  * needed.
  */
 template <typename VectorType>
-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 <typename VectorType>
-class MGSmootherBase : public EnableRefCountingByObserverPointer
+class MGSmootherBase : public EnableObserverPointer
 {
 public:
   /**
index 30e5c828516c0f7764733696f66d193737b8e397..e9b2bc22648f04b6f980ef79075f3cbd76a93fe1 100644 (file)
@@ -41,7 +41,7 @@ class DoFHandler;
  *
  * @ingroup mg
  */
-class MGConstrainedDoFs : public EnableRefCountingByObserverPointer
+class MGConstrainedDoFs : public EnableObserverPointer
 {
 public:
   using size_dof = std::vector<std::set<types::global_dof_index>>::size_type;
index a269e757b13dda832a6dc2d5cb789780ae7a7ec2..941ea9687970d4810a1d16ebee49c888780c197a 100644 (file)
@@ -216,7 +216,7 @@ namespace MGTransferGlobalCoarseningTools
  * accordingly.
  */
 template <typename VectorType>
-class MGTwoLevelTransferBase : public EnableRefCountingByObserverPointer
+class MGTwoLevelTransferBase : public EnableObserverPointer
 {
 public:
   static_assert(
index 6a9150103446a8c722e475e6137fb42ba80e2aed..1a362d6df9f035facc6f2b3266c48ecdefd32818 100644 (file)
@@ -159,7 +159,7 @@ namespace mg
  * MGTransferBase.
  */
 template <typename VectorType>
-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 <int dim, typename VectorType, typename TransferType>
-class PreconditionMG : public EnableRefCountingByObserverPointer
+class PreconditionMG : public EnableObserverPointer
 {
 public:
   /**
index b7b2b0530d2bbbbc57efee4dcd36f4d061349d07..84c68276cb3d1d6b6df6af7eec607ab68ce32f68 100644 (file)
@@ -38,7 +38,7 @@ namespace mg
    * multigrid with local refinement.
    */
   template <typename number>
-  class SparseMatrixCollection : public EnableRefCountingByObserverPointer
+  class SparseMatrixCollection : public EnableObserverPointer
   {
   public:
     void
index cf2e21dbe5bd6b4814737ef5782844508577df7b..249e2f8aa6348f8d84fd5fe7a0d0e31d7ff07ae2 100644 (file)
@@ -218,7 +218,7 @@ namespace NonMatching
    * held.
    */
   template <int dim, int spacedim = dim, typename Number = double>
-  class MappingInfo : public EnableRefCountingByObserverPointer
+  class MappingInfo : public EnableObserverPointer
   {
   public:
     /**
index b5f5e19aae2cf7c02eb24e91fb55bdf3d6b26ea5..1458db4770a61cf06b402adfd160cd5e4ac52e48 100644 (file)
@@ -105,7 +105,7 @@ namespace NonMatching
    * same way as for the discrete level set function.
    */
   template <int dim>
-  class MeshClassifier : public EnableRefCountingByObserverPointer
+  class MeshClassifier : public EnableObserverPointer
   {
   public:
     /**
index 67270b9e7e64fa5c7d3d3d67f30de4c4a97953b1..e6d7429d256fdf11039ef872af15c3a05f223f32 100644 (file)
@@ -579,7 +579,7 @@ namespace DataPostprocessorInputs
  * @ingroup output
  */
 template <int dim>
-class DataPostprocessor : public EnableRefCountingByObserverPointer
+class DataPostprocessor : public EnableObserverPointer
 {
 public:
   /**
index ccab37a762dcd4a192dbe217099cf05bdc69425e..983fc4f32b504cd2dd67016ac5441919210f09b0 100644 (file)
@@ -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:
   /**
index 33ce0d3a6426c00b2766588a02c9586cabfb8ab5..1f94d4b42893f8077026a07e58d8b67b0e5438a6 100644 (file)
@@ -59,7 +59,7 @@ namespace Particles
    * finite-element solution see step-19, step-68, step-70, and step-83.
    */
   template <int dim, int spacedim = dim>
-  class ParticleHandler : public EnableRefCountingByObserverPointer
+  class ParticleHandler : public EnableObserverPointer
   {
   public:
     /**
index 265ec521df3a37b4044d9b5fc0ca2627f84a207e..67984b99fdcf8a547533b49f63cb4395be67d95d 100644 (file)
@@ -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<bool> *const validity,
-                                              const std::string       &id) const
+EnableObserverPointer::subscribe(std::atomic<bool> *const validity,
+                                 const std::string       &id) const
 {
   std::lock_guard<std::mutex> lock(mutex);
 
@@ -149,9 +148,8 @@ EnableRefCountingByObserverPointer::subscribe(std::atomic<bool> *const validity,
 
 
 void
-EnableRefCountingByObserverPointer::unsubscribe(
-  std::atomic<bool> *const validity,
-  const std::string       &id) const
+EnableObserverPointer::unsubscribe(std::atomic<bool> *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);
 }
index 89de89c1d09bc300f3f85dda4eaecb3a2cc64bdc..461fcedc7625979bcf235e4f75f78653f3486aab 100644 (file)
@@ -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 <int dim>
 Quadrature<dim>::Quadrature(const Quadrature<dim != 1 ? 1 : 0> &q)
-  : EnableRefCountingByObserverPointer()
+  : EnableObserverPointer()
   , quadrature_points(Utilities::fixed_power<dim>(q.size()))
   , weights(Utilities::fixed_power<dim>(q.size()))
   , is_tensor_product_flag(true)
@@ -303,7 +303,7 @@ Quadrature<dim>::Quadrature(const Quadrature<dim != 1 ? 1 : 0> &q)
 
 template <int dim>
 Quadrature<dim>::Quadrature(const Quadrature<dim> &q)
-  : EnableRefCountingByObserverPointer()
+  : EnableObserverPointer()
   , quadrature_points(q.quadrature_points)
   , weights(q.weights)
   , is_tensor_product_flag(q.is_tensor_product_flag)
index 573e1e63f65b03fddcefb34e5cd7dca9ab129dce..f066750d173e78237c9daf4257ee6e6ad62e1bde 100644 (file)
@@ -12022,7 +12022,7 @@ template <int dim, int spacedim>
 DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<dim, spacedim>))
 Triangulation<dim, spacedim>::Triangulation(
   Triangulation<dim, spacedim> &&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<dim, spacedim>))
 Triangulation<dim, spacedim> &Triangulation<dim, spacedim>::operator=(
   Triangulation<dim, spacedim> &&tria) noexcept
 {
-  EnableRefCountingByObserverPointer::operator=(std::move(tria));
+  EnableObserverPointer::operator=(std::move(tria));
 
   smooth_grid                  = tria.smooth_grid;
   reference_cells              = std::move(tria.reference_cells);
index 23e985cb0b18d00de15fe947159659c55becca32..5cac9431979997207ffb442de8640a0e054fe310 100644 (file)
@@ -134,7 +134,7 @@ namespace hp
   template <int dim, int q_dim, typename FEValuesType>
   FEValuesBase<dim, q_dim, FEValuesType>::FEValuesBase(
     const FEValuesBase<dim, q_dim, FEValuesType> &other)
-    : EnableRefCountingByObserverPointer(other)
+    : EnableObserverPointer(other)
     , fe_collection(other.fe_collection)
     , mapping_collection(other.mapping_collection)
     , q_collection(other.q_collection)
index a719355da5ed842f60f78f8da73bc9b43ade2ef1..c164d7f6f60c1649de077424f9aa881d79fe820d 100644 (file)
@@ -29,7 +29,7 @@ ChunkSparsityPattern::ChunkSparsityPattern()
 
 
 ChunkSparsityPattern::ChunkSparsityPattern(const ChunkSparsityPattern &s)
-  : EnableRefCountingByObserverPointer()
+  : EnableObserverPointer()
   , chunk_size(s.chunk_size)
   , sparsity_pattern(s.sparsity_pattern)
 {
index dfa3626af7d5af8c27b98e41d520f25ed5143501..9a8534cb31fdf17abf914aca4c88d6c431b8f3b8 100644 (file)
@@ -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)
index 0ddaa7e7eb678ae3ceaa0ce75804265b03c61d21..d468afbd1ea1442aaf13568e4fc833a3d6cbd9ef 100644 (file)
@@ -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 &parallel_partitioner,
                    const MPI_Comm  communicator)
-      : EnableRefCountingByObserverPointer()
+      : EnableObserverPointer()
       , vector(new Epetra_FEVector(
           parallel_partitioner.make_trilinos_map(communicator, false)))
     {}
index 6af1b3e8e307f9d9a9aa23e58c15414aee2fbc2f..2c8fad8ca140acefd1e3242846a255741ea9f410 100644 (file)
@@ -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<EnableRefCountingByObserverPointer &>(*this) =
-        static_cast<EnableRefCountingByObserverPointer &&>(v);
+      static_cast<EnableObserverPointer &>(*this) =
+        static_cast<EnableObserverPointer &&>(v);
       swap(v);
     }
 
@@ -523,8 +523,8 @@ namespace TrilinosWrappers
     Vector &
     Vector::operator=(Vector &&v) noexcept
     {
-      static_cast<EnableRefCountingByObserverPointer &>(*this) =
-        static_cast<EnableRefCountingByObserverPointer &&>(v);
+      static_cast<EnableObserverPointer &>(*this) =
+        static_cast<EnableObserverPointer &&>(v);
       swap(v);
       return *this;
     }
index f8adea55fcaf150fc4d6498971cab585ef649751..7be6f3cbabe15c2084396374eb33e655c594a30c 100644 (file)
@@ -24,7 +24,7 @@
 // test computing square root of 2 with newton's method
 
 
-class SquareRoot : public EnableRefCountingByObserverPointer
+class SquareRoot : public EnableObserverPointer
 {
 public:
   void
index 994fe0b66969e73927a581e72e0e2785e2df2a6d..4a017416de99af4c891d2ab3a22768c2f5aee905 100644 (file)
@@ -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<EnableRefCountingByObserverPointer> smart_pointer_1(
-      &subscriptor_1);
-    ObserverPointer<EnableRefCountingByObserverPointer> smart_pointer_2(
-      &subscriptor_2);
+    EnableObserverPointer                  subscriptor_1;
+    EnableObserverPointer                  subscriptor_2;
+    ObserverPointer<EnableObserverPointer> smart_pointer_1(&subscriptor_1);
+    ObserverPointer<EnableObserverPointer> smart_pointer_2(&subscriptor_2);
 
     subscriptor_2 = subscriptor_1;
 
@@ -75,11 +73,10 @@ main()
   {
     deallog << "Checking copy construction" << std::endl;
 
-    EnableRefCountingByObserverPointer                  subscriptor_1;
-    ObserverPointer<EnableRefCountingByObserverPointer> smart_pointer_1(
-      &subscriptor_1);
+    EnableObserverPointer                  subscriptor_1;
+    ObserverPointer<EnableObserverPointer> 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<EnableRefCountingByObserverPointer> smart_pointer_1(
-      &subscriptor_1);
-    ObserverPointer<EnableRefCountingByObserverPointer> smart_pointer_2(
-      &subscriptor_2);
+    EnableObserverPointer                  subscriptor_1;
+    EnableObserverPointer                  subscriptor_2;
+    ObserverPointer<EnableObserverPointer> smart_pointer_1(&subscriptor_1);
+    ObserverPointer<EnableObserverPointer> 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<EnableRefCountingByObserverPointer> smart_pointer_1(
-      &subscriptor_1);
+    EnableObserverPointer                  subscriptor_1;
+    ObserverPointer<EnableObserverPointer> 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
index 36fde02d78091e713880f8da410fbb4bbb28708b..0c889ed98ca3c7807d432b774bd92c324c7f6722 100644 (file)
@@ -32,7 +32,7 @@
 std::vector<char> memory(10000);
 int               next = 0;
 
-class Test : public EnableRefCountingByObserverPointer
+class Test : public EnableObserverPointer
 {
   const char *name;
 
index b57800ac1a20fb99cfdba20855e7dd951eb32389..b05f1065252f0120be2daa106afad3a14d24b434 100644 (file)
@@ -27,7 +27,7 @@
 #include "../tests.h"
 
 
-class Test : public EnableRefCountingByObserverPointer
+class Test : public EnableObserverPointer
 {};
 
 
index 377fdebf27e0f9029fad759191d2f99822e66f00..7a998648ed3cce090fd217a66e9bc8ceeb9e6e87 100644 (file)
@@ -28,7 +28,7 @@
 #include "../tests.h"
 
 
-class Test : public EnableRefCountingByObserverPointer
+class Test : public EnableObserverPointer
 {};
 
 
index 46b319aa35f90e13c6d25b85d8ea8b5bbec1bc2f..880d9f167c2608d7e49f07bd2d34c6d13ba63006 100644 (file)
@@ -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<bool>                  dummy_a;
-  const char                        *foo_a = "a";
-  const char                        *foo_b = "b";
+  EnableObserverPointer subscriptor;
+  std::atomic<bool>     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<bool> dummy_b;
index 401fd196bf727827bd45908ea60992e809c36d2f..249be17af72d024ed5f836eae5575dc8b38f4d26 100644 (file)
@@ -3,24 +3,24 @@ DEAL::Exception: ExcNoSubscriber(object_info->name(), name)
 DEAL::
 --------------------------------------------------------
 An error occurred in file <enable_ref_counting_by_observer.cc> in function
-    void dealii::EnableRefCountingByObserverPointer::unsubscribe(std::atomic<bool>*, const string&) const
+    void dealii::EnableObserverPointer::unsubscribe(std::atomic<bool>*, const string&) const
 The violated condition was: 
     it != counter_map.end()
 Additional information: 
     No subscriber with identifier <b> 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 <enable_ref_counting_by_observer.cc> in function
-    void dealii::EnableRefCountingByObserverPointer::unsubscribe(std::atomic<bool>*, const string&) const
+    void dealii::EnableObserverPointer::unsubscribe(std::atomic<bool>*, 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!
 --------------------------------------------------------
 
index 319d80b422dc47f6dfc91c99b6667fbea0127ac6..b98b7259b9dfad68a098e35c4bf33cff6b6be768 100644 (file)
@@ -3,24 +3,24 @@ DEAL::Exception: ExcNoSubscriber(object_info->name(), name)
 DEAL::
 --------------------------------------------------------
 An error occurred in file <enable_ref_counting_by_observer.cc> in function
-    void dealii::EnableRefCountingByObserverPointer::unsubscribe(std::atomic<bool> *const, const std::string &) const
+    void dealii::EnableObserverPointer::unsubscribe(std::atomic<bool> *const, const std::string &) const
 The violated condition was: 
     it != counter_map.end()
 Additional information: 
     No subscriber with identifier <b> 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 <enable_ref_counting_by_observer.cc> in function
-    void dealii::EnableRefCountingByObserverPointer::unsubscribe(std::atomic<bool> *const, const std::string &) const
+    void dealii::EnableObserverPointer::unsubscribe(std::atomic<bool> *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!
 --------------------------------------------------------
 
index 17fdf90904ac4ffb1ec2ddd3b79b443ad762d9b4..013cba366d5de01e1477bdd1832ef4209e52d558 100644 (file)
@@ -3,24 +3,24 @@ DEAL::Exception: ExcNoSubscriber(object_info->name(), name)
 DEAL::
 --------------------------------------------------------
 An error occurred in file <enable_ref_counting_by_observer.cc> in function
-    void dealii::EnableRefCountingByObserverPointer::unsubscribe(std::atomic<bool>*, const std::string&) const
+    void dealii::EnableObserverPointer::unsubscribe(std::atomic<bool>*, const std::string&) const
 The violated condition was: 
     it != counter_map.end()
 Additional information: 
     No subscriber with identifier <b> 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 <enable_ref_counting_by_observer.cc> in function
-    void dealii::EnableRefCountingByObserverPointer::unsubscribe(std::atomic<bool>*, const std::string&) const
+    void dealii::EnableObserverPointer::unsubscribe(std::atomic<bool>*, 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!
 --------------------------------------------------------
 
index f88e75f4e2cd84ba11969853fa3e384c4efe9f0a..27d7542855aa986eaad65ca69e1382b927900445 100644 (file)
@@ -3,24 +3,24 @@ DEAL::Exception: ExcNoSubscriber(object_info->name(), name)
 DEAL::
 --------------------------------------------------------
 An error occurred in file <enable_ref_counting_by_observer.cc> in function
-    void dealii::EnableRefCountingByObserverPointer::unsubscribe(std::atomic<bool> *, const std::__cxx11::basic_string<char, std::char_traits<char>, std::allocator<char>> &) const
+    void dealii::EnableObserverPointer::unsubscribe(std::atomic<bool> *, const std::__cxx11::basic_string<char, std::char_traits<char>, std::allocator<char>> &) const
 The violated condition was: 
     it != counter_map.end()
 Additional information: 
     No subscriber with identifier <b> 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 <enable_ref_counting_by_observer.cc> in function
-    void dealii::EnableRefCountingByObserverPointer::unsubscribe(std::atomic<bool> *, const std::__cxx11::basic_string<char, std::char_traits<char>, std::allocator<char>> &) const
+    void dealii::EnableObserverPointer::unsubscribe(std::atomic<bool> *, const std::__cxx11::basic_string<char, std::char_traits<char>, std::allocator<char>> &) 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!
 --------------------------------------------------------
 
index f122783f4b1a1d6974e93fdd942ddc455fa2ca33..0a4e4a03bca746fd3a635fbcf1b6b52a4dede710 100644 (file)
@@ -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<bool>                  dummy_a;
-  const char                        *foo        = "a";
-  const std::string                  foo_string = "a";
+  EnableObserverPointer subscriptor;
+  std::atomic<bool>     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());
 
index 30e3c994e01bb03ce35592d7122b312c0251527b..b996d40b7c067ccc75683999f7efab157e508e1f 100644 (file)
@@ -288,7 +288,7 @@ LaplaceProblem<dim>::LaplaceProblem()
 // finite element object which counts
 // how many objects use that finite
 // element (this is what the
-// <code>EnableRefCountingByObserverPointer</code>/<code>ObserverPointer</code>
+// <code>EnableObserverPointer</code>/<code>ObserverPointer</code>
 // class pair is used for, in case
 // you want something like this for
 // your own programs; see step-7 for
index d594c9f11ca3f6094b8b13ddc8e6f1a6d74206d3..44364ca7ba85e773e52d8a9d7078fcd51ead755a 100644 (file)
@@ -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
index 7c866ce7c799a773502a83d73102c352a7ab4fb3..122f9f794a07c9cdb464dc8f5ecd50ab0c376834 100644 (file)
@@ -866,7 +866,7 @@ namespace LaplaceSolver
 namespace Data
 {
   template <int dim>
-  struct SetUpBase : public EnableRefCountingByObserverPointer
+  struct SetUpBase : public EnableObserverPointer
   {
     virtual const Function<dim> &
     get_boundary_values() const = 0;
@@ -1095,7 +1095,7 @@ namespace Data
 namespace DualFunctional
 {
   template <int dim>
-  class DualFunctionalBase : public EnableRefCountingByObserverPointer
+  class DualFunctionalBase : public EnableObserverPointer
   {
   public:
     virtual void
index 41df113156dbb2fc961d02833704a12dc54657e8..a273e46c5f98bcc10e6551be4722fdda829deea2 100644 (file)
@@ -312,7 +312,7 @@ namespace Step22
 
 
   template <class Matrix, class Preconditioner>
-  class InverseMatrix : public EnableRefCountingByObserverPointer
+  class InverseMatrix : public EnableObserverPointer
   {
   public:
     InverseMatrix(const Matrix &m, const Preconditioner &preconditioner);
@@ -353,7 +353,7 @@ namespace Step22
   }
 
   template <class Preconditioner>
-  class SchurComplement : public EnableRefCountingByObserverPointer
+  class SchurComplement : public EnableObserverPointer
   {
   public:
     SchurComplement(
index 87c48d9d7a700a60ac55f0f160b3a53c7d2d24d8..236e6a53965e5b7fd96bf9d47bbb148a001b8bd5 100644 (file)
@@ -52,7 +52,7 @@
 namespace Step
 {
   template <int dim>
-  class Problem : public EnableRefCountingByObserverPointer
+  class Problem : public EnableObserverPointer
   {
   public:
     Problem();
index 88c12f552ceedd92392f24136ea2fbd5ed16593c..5eaa7065778b0450ab7678c86ed62c717b20cea8 100644 (file)
@@ -45,7 +45,7 @@
 const unsigned int n_functionals = 3;
 
 template <int dim>
-class Local : public EnableRefCountingByObserverPointer
+class Local : public EnableObserverPointer
 {
 public:
   using CellInfo = EmptyInfo;
index e2eee30ffa014564d2bdc247b242e151a174ffe2..4ea5cb2c598c46e139d7cdf8ad909a4d4b1fa924 100644 (file)
@@ -43,7 +43,7 @@
 const unsigned int n_functionals = 3;
 
 template <int dim>
-class Local : public EnableRefCountingByObserverPointer
+class Local : public EnableObserverPointer
 {
 public:
   using CellInfo = EmptyInfo;
index 5324199520f1fbea67cfb7ff14fe68ba0cc3419c..aa837b261afebc1be3792df923135b8a221d3fea 100644 (file)
@@ -39,7 +39,7 @@
 // Define a class that fills all available entries in the info objects
 // with recognizable numbers.
 template <int dim>
-class Local : public EnableRefCountingByObserverPointer
+class Local : public EnableObserverPointer
 {
 public:
   using CellInfo = MeshWorker::IntegrationInfo<dim>;
index 7214cadd134f2c1199f45449605175bcb7aa1eb5..8f266bc26060ff566d63c57e899897068bc0295d 100644 (file)
@@ -38,7 +38,7 @@
 
 // Use local matrices for Laplacian / interior penalty DG
 template <int dim>
-class MatrixIntegrator : public EnableRefCountingByObserverPointer
+class MatrixIntegrator : public EnableObserverPointer
 {
 public:
   static void
index f553806aa6e6cf1f184ab2e56a05f0f529e51f02..fc221c653c2cd70dce5f8570e86dc37be1eac90e 100644 (file)
@@ -39,7 +39,7 @@
 
 // Local integrators fill every matrix entry with 10*block_row + block_col
 template <int dim>
-class MatrixIntegrator : public EnableRefCountingByObserverPointer
+class MatrixIntegrator : public EnableObserverPointer
 {
 public:
   static void
index df017379c7268a863de11f51c8273d50459bdacd..04b62bab543281ff0dc8b0ee8aab3caa14bfaa75 100644 (file)
@@ -40,7 +40,7 @@
 // Define a class that fills all available entries in the info objects
 // with recognizable numbers.
 template <int dim>
-class Local : public EnableRefCountingByObserverPointer
+class Local : public EnableObserverPointer
 {
 public:
   using CellInfo = MeshWorker::IntegrationInfo<dim>;
index 810e696a6433815999a9355763c70b66e5361ccc..89a8aa7ea58cd1a4d0b0aae1e69c16160898b710 100644 (file)
@@ -98,7 +98,7 @@ private:
 };
 
 template <typename SparseMatrixType>
-class MySparseMatrix : public EnableRefCountingByObserverPointer
+class MySparseMatrix : public EnableObserverPointer
 {
 public:
   MySparseMatrix(const SparseMatrixType &sparse_matrix)
index 21756826ceb12cad19810e6e8b26f9d274f6e24a..4d4ce9f5a4f6aa5b65c198af87f68308f32cc5b6 100644 (file)
@@ -97,7 +97,7 @@ private:
 };
 
 template <typename SparseMatrixType>
-class MySparseMatrix : public EnableRefCountingByObserverPointer
+class MySparseMatrix : public EnableObserverPointer
 {
 public:
   MySparseMatrix(const SparseMatrixType &sparse_matrix)
index 5530835e22ac4057215af4a4e0a94d1d55535814..53f74a0154b388087082261d6772f94991985411 100644 (file)
@@ -47,7 +47,7 @@ template <int dim,
           int fe_degree,
           int n_q_points_1d = fe_degree + 1,
           typename number   = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
index ec5a4e47c84e634006eb8e957d3624b339a60e1d..c8d70b350cd3b19df7817f3b44be801b5ef5bf3e 100644 (file)
@@ -55,7 +55,7 @@
 
 
 template <int dim, typename number = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
index 85f620f1858bfca1e3305b421b0343b47a498392..fab22e0a0eb57cc2a8f2a8a94e9e54ab36983f77 100644 (file)
@@ -54,7 +54,7 @@
 
 
 template <int dim, typename number = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
index 3110fa5e495425f441826beb74f196fec4025c6a..b7bad6ba7673292f7972de65b13c4c92ffc13c52 100644 (file)
@@ -55,7 +55,7 @@
 
 
 template <int dim, typename number = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
index a2546e81fb0875c0143afe0ca04a4bc6d8c157eb..4b344eb08aa1a3fb1459ff965aed1b330bfb8d01 100644 (file)
@@ -54,7 +54,7 @@ template <int dim,
           int fe_degree,
           int n_q_points_1d = fe_degree + 1,
           typename number   = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   LaplaceOperator(){};
index b84ac1c6699a000ed97563dc08907dea96b1622f..92ca3efc36be040496b2844aa8913f50b2261c25 100644 (file)
@@ -54,7 +54,7 @@ template <int dim,
           int fe_degree,
           int n_q_points_1d = fe_degree + 1,
           typename number   = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   LaplaceOperator(){};
@@ -400,7 +400,7 @@ private:
 
 
 template <typename LAPLACEOPERATOR>
-class MGInterfaceMatrix : public EnableRefCountingByObserverPointer
+class MGInterfaceMatrix : public EnableObserverPointer
 {
 public:
   void
index 00d2574038741f47430e1de24e9c514b8263dad0..9eda3655eaf8de5505f91108cf8ebab6ea8a96c3 100644 (file)
@@ -54,7 +54,7 @@ template <int dim,
           int fe_degree,
           int n_q_points_1d = fe_degree + 1,
           typename number   = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
@@ -407,7 +407,7 @@ private:
 
 
 template <typename LAPLACEOPERATOR>
-class MGInterfaceMatrix : public EnableRefCountingByObserverPointer
+class MGInterfaceMatrix : public EnableObserverPointer
 {
 public:
   void
index ecfec53f0a4dce62d3cadcb2b21a65541fec5e1a..d97546493b291397e16d0ad88a68a90f3755d18a 100644 (file)
@@ -51,7 +51,7 @@ template <int dim,
           int fe_degree,
           int n_q_points_1d = fe_degree + 1,
           typename number   = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
@@ -404,7 +404,7 @@ private:
 
 
 template <typename LAPLACEOPERATOR>
-class MGInterfaceMatrix : public EnableRefCountingByObserverPointer
+class MGInterfaceMatrix : public EnableObserverPointer
 {
 public:
   void
index 6d3dd57fbd156c3f09685fbd10a7fddb877281d2..3e77d84e3be056db3ccf82bb0d1fd3a5b9433f5b 100644 (file)
@@ -75,14 +75,14 @@ template <int dim,
           int n_q_points_1d = fe_degree + 1,
           typename BlockVectorType =
             LinearAlgebra::distributed::BlockVector<double>>
-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
index 55f9e7c313f2d6453a418c6a3d3d05f4ba2b001b..0fdc9ee4e8291af3303bbab91ed0143d95a13970 100644 (file)
@@ -68,14 +68,14 @@ template <int dim,
           int n_q_points_1d,
           typename BlockVectorType =
             LinearAlgebra::distributed::BlockVector<double>>
-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
index 38d6eb06ac0b2887c22980fec237b9d6b550f1c6..3206ef6d8efdbdbac6980afc02563b80cc5dd357 100644 (file)
@@ -57,7 +57,7 @@ template <int dim,
           int fe_degree,
           int n_q_points_1d = fe_degree + 1,
           typename number   = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
index 7381351c80620b83dd945ba2d4d1ddd49b708f21..005d60caf7a0410212334d1c8f097e82e4c27b89 100644 (file)
@@ -50,7 +50,7 @@
 
 
 template <int dim, typename number = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
index 628ecc31c6290cb9c67905b1e840917c73897608..37225953fb6e9bbe1516d450e5da9164cf55601c 100644 (file)
@@ -51,7 +51,7 @@
 
 
 template <int dim, typename number = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
index 5c684dab5883a0bfb497986e8948d85c2f23ed45..1994600d6f02e7a7b9dce2d56ee2c483b868f9f0 100644 (file)
@@ -52,7 +52,7 @@ template <int dim,
           int fe_degree,
           int n_q_points_1d = fe_degree + 1,
           typename number   = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
index 58d8a87b52e68604274e6b79d0ddc5c6eeb050a8..8787bac2718f43e05679617f7106a57b2d602be8 100644 (file)
@@ -49,7 +49,7 @@
 
 
 template <int dim, typename number = double>
-class HelmholtzOperator : public EnableRefCountingByObserverPointer
+class HelmholtzOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
index c38b44fa6a86ce43661092614acbc58adbf9db5b..52f50f3b6093c2bfe2e0d55082586b83d96e8bcd 100644 (file)
@@ -118,7 +118,7 @@ namespace Step37
 
 
   template <int dim, int fe_degree, typename number>
-  class LaplaceOperator : public EnableRefCountingByObserverPointer
+  class LaplaceOperator : public EnableObserverPointer
   {
   public:
     LaplaceOperator();
@@ -171,7 +171,7 @@ namespace Step37
 
   template <int dim, int fe_degree, typename number>
   LaplaceOperator<dim, fe_degree, number>::LaplaceOperator()
-    : EnableRefCountingByObserverPointer()
+    : EnableObserverPointer()
   {}
 
 
index 0d779619f3a35639dfe048f6cb59a9b102470a86..cf8f976ec9d6c27b4ba714b7b249548c9bc5a707 100644 (file)
@@ -87,7 +87,7 @@ namespace StokesClass
               class MassMatrixType,
               class PreconditionerA,
               class PreconditionerMp>
-    class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer
+    class BlockSchurPreconditioner : public EnableObserverPointer
     {
     public:
       /**
index 010aa43544997519a687255c2614ef69b1bb8477..db5fdaca950b3590cc5a4e162191cc9a916873f7 100644 (file)
@@ -75,7 +75,7 @@ DummyOperator<dim, fe_degree>::operator()(
 
 
 template <int dim, int fe_degree>
-class DummyMatrixFree : public EnableRefCountingByObserverPointer
+class DummyMatrixFree : public EnableObserverPointer
 {
 public:
   DummyMatrixFree(const Portable::MatrixFree<dim, double> &data_in,
index 9d4d4371549c02d739be849c62cb80bd99141c85..49fb2aaaff773f9890b6c1cd8afa227164e2913c 100644 (file)
@@ -170,7 +170,7 @@ template <int dim,
           typename VectorType =
             LinearAlgebra::distributed::Vector<double, MemorySpace::Default>,
           int n_q_points_1d = fe_degree + 1>
-class MatrixFreeTest : public EnableRefCountingByObserverPointer
+class MatrixFreeTest : public EnableObserverPointer
 {
 public:
   MatrixFreeTest(const Portable::MatrixFree<dim, Number> &data_in,
index cc10048e62102b868293af0f51d128ccd63e298c..61bb8e401938bf787da1b1cf59f3793c63ecc7f5 100644 (file)
@@ -46,7 +46,7 @@
 // Define a class that fills all available entries in the info objects
 // with recognizable numbers.
 template <int dim>
-class Local : public EnableRefCountingByObserverPointer
+class Local : public EnableObserverPointer
 {
 public:
   using CellInfo = MeshWorker::IntegrationInfo<dim>;
index 2a62b1e7ee58109f4f023badecbcb43f3efe9d8b..7021a9849ad8730151904e85f22d5e6f8c4634e2 100644 (file)
@@ -55,7 +55,7 @@
 
 
 template <int dim, typename number = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
index 702da3a742deb1087ce8ba833449b696de5e976b..b3d493e8727ec1f6a722971bb0136ed4b23d62be 100644 (file)
@@ -54,7 +54,7 @@
 
 
 template <int dim, typename number = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
index df8fd0782c634a14a4078683026487c13f612be1..d95bff8a8be1f7f3459391b59bec934c194083c7 100644 (file)
@@ -55,7 +55,7 @@
 
 
 template <int dim, typename number = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
index 754cb0de7fac088f936421bef0e9f5b81739b460..efcd92a45d379b892be99232c107af3e6ef88376 100644 (file)
@@ -58,7 +58,7 @@
 #include "../tests.h"
 
 template <int dim_, int n_components = dim_, typename Number = double>
-class Operator : public EnableRefCountingByObserverPointer
+class Operator : public EnableObserverPointer
 {
 public:
   using value_type = Number;
index 67cbe0068558d938075e1721094fc1a9b664f2c7..81b69bf9fcf0a9aac3caf5df9637dac36db02874 100644 (file)
@@ -54,7 +54,7 @@ template <int dim,
           int fe_degree,
           int n_q_points_1d = fe_degree + 1,
           typename number   = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   LaplaceOperator(){};
index cc798860531263f430fb9507e307ac5c94f55244..4dd31165df823bf5e380bec67a8e76ab6f46bafe 100644 (file)
@@ -54,7 +54,7 @@ template <int dim,
           int fe_degree,
           int n_q_points_1d = fe_degree + 1,
           typename number   = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   LaplaceOperator(){};
@@ -400,7 +400,7 @@ private:
 
 
 template <typename LAPLACEOPERATOR>
-class MGInterfaceMatrix : public EnableRefCountingByObserverPointer
+class MGInterfaceMatrix : public EnableObserverPointer
 {
 public:
   void
index dc145420d196a06899aff3fff098efe1d90ac5de..4b404743a8eaa34c1b0f4c9d77e453437cf1362d 100644 (file)
@@ -54,7 +54,7 @@ template <int dim,
           int fe_degree,
           int n_q_points_1d = fe_degree + 1,
           typename number   = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
@@ -407,7 +407,7 @@ private:
 
 
 template <typename LAPLACEOPERATOR>
-class MGInterfaceMatrix : public EnableRefCountingByObserverPointer
+class MGInterfaceMatrix : public EnableObserverPointer
 {
 public:
   void
index 529da593afc1e849ad15cf821b7a05101ffbbf4a..89d726f8a3efc6592a767e09fe3ebf2485555a2f 100644 (file)
@@ -51,7 +51,7 @@ template <int dim,
           int fe_degree,
           int n_q_points_1d = fe_degree + 1,
           typename number   = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
@@ -404,7 +404,7 @@ private:
 
 
 template <typename LAPLACEOPERATOR>
-class MGInterfaceMatrix : public EnableRefCountingByObserverPointer
+class MGInterfaceMatrix : public EnableObserverPointer
 {
 public:
   void
index f58b47531a752e6b7cf6a51500193b1fc9c6537a..28c6ac78539d5256d9f891b64418bdee03391a75 100644 (file)
@@ -75,14 +75,14 @@ template <int dim,
           int n_q_points_1d = fe_degree + 1,
           typename BlockVectorType =
             LinearAlgebra::distributed::BlockVector<double>>
-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
index 7cd7fe8b99ce9eb85449a3157a0160c1693e4947..649d9a9a77b3248c32504dadadafbc904071d66a 100644 (file)
@@ -68,14 +68,14 @@ template <int dim,
           int n_q_points_1d,
           typename BlockVectorType =
             LinearAlgebra::distributed::BlockVector<double>>
-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
index bcfa3c96488a6175572e66cdea6c98aafbbb8210..34f0be9e170a3c193dae2e044603f405257cb8d7 100644 (file)
@@ -57,7 +57,7 @@ template <int dim,
           int fe_degree,
           int n_q_points_1d = fe_degree + 1,
           typename number   = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
index 75e4ea10efd0e67cad8efee6d8d3f08327731c44..ad050023c9bbd143be47b2eb4bdd2b2a1c6a097c 100644 (file)
@@ -50,7 +50,7 @@
 
 
 template <int dim, typename number = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
index 78fafa8ff1e5ad9ff568a580143c16767aa2688b..a94591c61270050cb487869812de4946e863b833 100644 (file)
@@ -51,7 +51,7 @@
 
 
 template <int dim, typename number = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
index 65af18c078fe57a13aa19d7659560eb45ecd114b..7ec675649634c617252279a4bb84a883903ed11d 100644 (file)
@@ -52,7 +52,7 @@ template <int dim,
           int fe_degree,
           int n_q_points_1d = fe_degree + 1,
           typename number   = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
index 09237aa19b2cffac9b56790dabc0d836b5c41ec5..ea9d2f50382cfaab832c8cc12512bc99d3f1eb89 100644 (file)
@@ -87,7 +87,7 @@ namespace StokesClass
               class MassMatrixType,
               class PreconditionerA,
               class PreconditionerMp>
-    class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer
+    class BlockSchurPreconditioner : public EnableObserverPointer
     {
     public:
       /**
index b9d540452d45b1ab2e8ab9a87d8275f8d2644738..58b35bfdeb1ea1c3c7a6e58603f9a7f24d9d46a7 100644 (file)
@@ -142,7 +142,7 @@ diff(Vector<double>        &diff,
 
 
 template <int dim>
-class OutputCreator : public EnableRefCountingByObserverPointer
+class OutputCreator : public EnableObserverPointer
 {
 public:
   void
index d490c12ef39ad691ba5d71f17a139274d308b98b..1d26288c650afa2ff813efe146b1f12d37dc91c2 100644 (file)
@@ -189,7 +189,7 @@ print(const DoFHandler<dim>          &dof,
 }
 
 template <int dim>
-class OutputCreator : public EnableRefCountingByObserverPointer
+class OutputCreator : public EnableObserverPointer
 {
 public:
   void
index 93fc1c10be0dae002465e06a4269eb10ab8b9e57..bfad4b552ba2d5463fcbd204fe52c5ee09297f11 100644 (file)
@@ -88,7 +88,7 @@ namespace StokesClass
               class MassMatrixType,
               class PreconditionerA,
               class PreconditionerMp>
-    class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer
+    class BlockSchurPreconditioner : public EnableObserverPointer
     {
     public:
       /**
index 292bc38b741f553d2049cd2632b907ab54a36d42..491b2d6e1a3a1f04d2b2ae68616c4abcee648dd0 100644 (file)
@@ -204,7 +204,7 @@ RightHandSide<dim>::value_list(const std::vector<Point<dim>> &vp,
 
 
 template <class MatrixType, class PreconditionerType>
-class InverseMatrix : public EnableRefCountingByObserverPointer
+class InverseMatrix : public EnableObserverPointer
 {
 public:
   InverseMatrix(const MatrixType &m, const PreconditionerType &preconditioner);
@@ -243,7 +243,7 @@ InverseMatrix<MatrixType, PreconditionerType>::vmult(
 
 
 template <class PreconditionerType>
-class SchurComplement : public EnableRefCountingByObserverPointer
+class SchurComplement : public EnableObserverPointer
 {
 public:
   SchurComplement(
index ca28f3a6c893077b54a20cb3e5e59f4aa9f3c7df..cc6313a7aa030ec6bc8a7a98ca5a86f97289b6cd 100644 (file)
@@ -79,7 +79,7 @@ dealii::ConditionalOStream debug_output(std::cout, false);
 
 
 template <int dim, typename number = double>
-class LaplaceOperator : public EnableRefCountingByObserverPointer
+class LaplaceOperator : public EnableObserverPointer
 {
 public:
   using value_type = number;
index 9f44ee99b37f33e9dc687281a4870e7ed49e7210..2f1b3d52cad2c7d3ec4099741ae0a67ecaa21dba 100644 (file)
@@ -202,7 +202,7 @@ RightHandSide<dim>::value_list(const std::vector<Point<dim>> &vp,
 
 
 template <class MatrixType, class PreconditionerType>
-class InverseMatrix : public EnableRefCountingByObserverPointer
+class InverseMatrix : public EnableObserverPointer
 {
 public:
   InverseMatrix(const MatrixType &m, const PreconditionerType &preconditioner);
@@ -241,7 +241,7 @@ InverseMatrix<MatrixType, PreconditionerType>::vmult(
 
 
 template <class PreconditionerType>
-class SchurComplement : public EnableRefCountingByObserverPointer
+class SchurComplement : public EnableObserverPointer
 {
 public:
   SchurComplement(
index 1649405ad9a8665a928d31c23ff4c2fa2f4da0ad..e463b2dfac9e0c717cbfe8647380595366a63919 100644 (file)
@@ -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)
index 27887db8e4039d79b556161bd6d171f5211a5ff0..69fa0d5f2af2e13c67f281aaa5bfc85438555b78 100644 (file)
@@ -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)
index 7f42cbfe4e50fa8a21afe9420f2c73072fc9f306..560effa901d078bb67dfd6c5c22e1fabc281ea29 100644 (file)
@@ -129,7 +129,7 @@ namespace Step31
   namespace LinearSolvers
   {
     template <class MatrixType, class PreconditionerType>
-    class InverseMatrix : public EnableRefCountingByObserverPointer
+    class InverseMatrix : public EnableObserverPointer
     {
     public:
       InverseMatrix(const MatrixType         &m,
@@ -169,7 +169,7 @@ namespace Step31
         }
     }
     template <class PreconditionerTypeA, class PreconditionerTypeMp>
-    class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer
+    class BlockSchurPreconditioner : public EnableObserverPointer
     {
     public:
       BlockSchurPreconditioner(
index f519d446f4307e1ac97d0cc326f11cd267a8447a..e6dffbf5eccd31354495052eaa67bc267b5b4d27 100644 (file)
@@ -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 Matrix, class Preconditioner>
-    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 PreconditionerA, class PreconditionerS>
-    class BlockDiagonalPreconditioner
-      : public EnableRefCountingByObserverPointer
+    class BlockDiagonalPreconditioner : public EnableObserverPointer
     {
     public:
       BlockDiagonalPreconditioner(const PreconditionerA &preconditioner_A,
index 1e0818bbb170f354f140961c953ade2aee4afff6..81cb4f59f781cd576f2a31fec7f5705870f1df80 100644 (file)
@@ -259,7 +259,7 @@ namespace Step56
   }
 
   template <class PreconditionerAType, class PreconditionerSType>
-  class BlockSchurPreconditioner : public EnableRefCountingByObserverPointer
+  class BlockSchurPreconditioner : public EnableObserverPointer
   {
   public:
     BlockSchurPreconditioner(

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.