]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Rename a constructor argument and member variable. 17700/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Wed, 18 Sep 2024 21:57:28 +0000 (15:57 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Wed, 18 Sep 2024 21:57:28 +0000 (15:57 -0600)
include/deal.II/base/mpi_compute_index_owner_internal.h
source/base/mpi_compute_index_owner_internal.cc

index e95096ca924111e1000aa6be9bde149fbffe5be2..012e03d51aece488ef6c3553aba0f9fbc5ad5be5 100644 (file)
@@ -227,7 +227,7 @@ namespace Utilities
                                      const IndexSet &indices_to_look_up,
                                      const MPI_Comm  comm,
                                      std::vector<unsigned int> &owning_ranks,
-                                     const bool track_index_requests = false);
+                                     const bool track_index_requesters = false);
 
           /**
            * The index space which describes the locally owned space.
@@ -262,7 +262,7 @@ namespace Utilities
            * indices, and what those indices were. If true, it will be added
            * into `requesters` and can be queried by `get_requesters()`.
            */
-          const bool track_index_requests;
+          const bool track_index_requesters;
 
           /**
            * The result of the index owner computation: To each index
index 44dc278d520c3f433fc4adb2b3af1d267f4df6fb..356613e5f2b001e345cf27357e2d2dfbe9be93f1 100644 (file)
@@ -458,13 +458,13 @@ namespace Utilities
           const IndexSet            &indices_to_look_up,
           const MPI_Comm             comm,
           std::vector<unsigned int> &owning_ranks,
-          const bool                 track_index_requests)
+          const bool                 track_index_requesters)
           : owned_indices(owned_indices)
           , indices_to_look_up(indices_to_look_up)
           , comm(comm)
           , my_rank(this_mpi_process(comm))
           , n_procs(n_mpi_processes(comm))
-          , track_index_requests(track_index_requests)
+          , track_index_requesters(track_index_requesters)
           , owning_ranks(owning_ranks)
         {
           dict.reinit(owned_indices, comm);
@@ -488,7 +488,7 @@ namespace Utilities
                   dict.actually_owning_ranks[i - dict.local_range.first];
                 request_buffer.push_back(actual_owner);
 
-                if (track_index_requests)
+                if (track_index_requesters)
                   append_index_origin(i - dict.local_range.first,
                                       other_rank,
                                       actual_owner,
@@ -513,7 +513,7 @@ namespace Utilities
                 {
                   owning_ranks[index] =
                     dict.actually_owning_ranks[i - dict.local_range.first];
-                  if (track_index_requests)
+                  if (track_index_requesters)
                     append_index_origin(i - dict.local_range.first,
                                         my_rank,
                                         owning_ranks[index],
@@ -575,7 +575,7 @@ namespace Utilities
         std::map<unsigned int, IndexSet>
         ConsensusAlgorithmsPayload::get_requesters()
         {
-          Assert(track_index_requests,
+          Assert(track_index_requesters,
                  ExcMessage("Must enable index range tracking in "
                             "constructor of ConsensusAlgorithmProcess"));
 

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.