Reference documentation for deal.II version 9.2.0
\(\newcommand{\dealvcentcolon}{\mathrel{\mathop{:}}}\) \(\newcommand{\dealcoloneq}{\dealvcentcolon\mathrel{\mkern-1.2mu}=}\) \(\newcommand{\jump}[1]{\left[\!\left[ #1 \right]\!\right]}\) \(\newcommand{\average}[1]{\left\{\!\left\{ #1 \right\}\!\right\}}\)
Public Member Functions | Public Attributes | Private Member Functions | List of all members
Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload Class Reference

#include <deal.II/base/mpi_compute_index_owner_internal.h>

Inheritance diagram for Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload:
[legend]

Public Member Functions

 ConsensusAlgorithmsPayload (const IndexSet &owned_indices, const IndexSet &indices_to_look_up, const MPI_Comm &comm, std::vector< unsigned int > &owning_ranks, const bool track_index_requests=false)
 
virtual void answer_request (const unsigned int other_rank, const std::vector< std::pair< types::global_dof_index, types::global_dof_index >> &buffer_recv, std::vector< unsigned int > &request_buffer) override
 
virtual std::vector< unsigned intcompute_targets () override
 
virtual void create_request (const unsigned int other_rank, std::vector< std::pair< types::global_dof_index, types::global_dof_index >> &send_buffer) override
 
virtual void prepare_buffer_for_answer (const unsigned int other_rank, std::vector< unsigned int > &recv_buffer) override
 
virtual void read_answer (const unsigned int other_rank, const std::vector< unsigned int > &recv_buffer) override
 
std::map< unsigned int, IndexSetget_requesters ()
 
- Public Member Functions inherited from Utilities::MPI::ConsensusAlgorithms::Process< std::pair< types::global_dof_index, types::global_dof_index >, unsigned int >
virtual ~Process ()=default
 
virtual void create_request (const unsigned int other_rank, std::vector< std::pair< types::global_dof_index, types::global_dof_index > > &send_buffer)
 
virtual void answer_request (const unsigned int other_rank, const std::vector< std::pair< types::global_dof_index, types::global_dof_index > > &buffer_recv, std::vector< unsigned int > &request_buffer)
 

Public Attributes

const IndexSetowned_indices
 
const IndexSetindices_to_look_up
 
const MPI_Comm comm
 
const unsigned int my_rank
 
const unsigned int n_procs
 
const bool track_index_requests
 
std::vector< unsigned int > & owning_ranks
 
std::vector< std::vector< std::pair< unsigned int, std::vector< std::pair< unsigned int, unsigned int > > > > > requesters
 
Dictionary dict
 
std::map< unsigned int, std::vector< types::global_dof_index > > indices_to_look_up_by_dict_rank
 
std::map< unsigned int, std::vector< unsigned int > > recv_indices
 

Private Member Functions

void append_index_origin (const types::global_dof_index index, unsigned int &owner_index, const unsigned int rank_of_request)
 

Detailed Description

Specialization of ConsensusAlgorithms::Process for the context of Utilities::MPI::compute_index_owner() and Utilities::MPI::Partitioner::set_ghost_indices() with additional payload.

Definition at line 538 of file mpi_compute_index_owner_internal.h.

Constructor & Destructor Documentation

◆ ConsensusAlgorithmsPayload()

Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload::ConsensusAlgorithmsPayload ( const IndexSet owned_indices,
const IndexSet indices_to_look_up,
const MPI_Comm comm,
std::vector< unsigned int > &  owning_ranks,
const bool  track_index_requests = false 
)
inline

Constructor.

Definition at line 547 of file mpi_compute_index_owner_internal.h.

Member Function Documentation

◆ answer_request()

virtual void Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload::answer_request ( const unsigned int  other_rank,
const std::vector< std::pair< types::global_dof_index, types::global_dof_index >> &  buffer_recv,
std::vector< unsigned int > &  request_buffer 
)
inlineoverridevirtual

Implementation of Utilities::MPI::ConsensusAlgorithms::Process::answer_request(), adding the owner of a particular index in request_buffer (and keeping track of who requested a particular index in case that information is also desired).

Definition at line 645 of file mpi_compute_index_owner_internal.h.

◆ compute_targets()

virtual std::vector<unsigned int> Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload::compute_targets ( )
inlineoverridevirtual

◆ create_request()

virtual void Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload::create_request ( const unsigned int  other_rank,
std::vector< std::pair< types::global_dof_index, types::global_dof_index >> &  send_buffer 
)
inlineoverridevirtual

◆ prepare_buffer_for_answer()

virtual void Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload::prepare_buffer_for_answer ( const unsigned int  other_rank,
std::vector< unsigned int > &  recv_buffer 
)
inlineoverridevirtual

◆ read_answer()

virtual void Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload::read_answer ( const unsigned int  other_rank,
const std::vector< unsigned int > &  recv_buffer 
)
inlineoverridevirtual

◆ get_requesters()

std::map<unsigned int, IndexSet> Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload::get_requesters ( )
inline

Resolve the origin of the requests by sending the information accumulated in terms of the dictionary owners during the run of the consensus algorithm back to the owner in the original IndexSet. This requires some point-to-point communication.

Returns
Map of processors and associated ranges of indices that are requested from the current rank

Definition at line 782 of file mpi_compute_index_owner_internal.h.

◆ append_index_origin()

void Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload::append_index_origin ( const types::global_dof_index  index,
unsigned int owner_index,
const unsigned int  rank_of_request 
)
inlineprivate

Stores the index request in the requesters field. We first find out the owner of the index that was requested (using the guess in owner_index, as we typically might look up on the same rank several times in a row, which avoids the binary search in Dictionary::get_owning_rank_index(). Once we know the rank of the owner, we the vector entry with the rank of the request. Here, we utilize the fact that requests are processed rank-by-rank, so we can simply look at the end of the vector if there is already some data stored or not. Finally, we build ranges, again using that the index list is sorted and we therefore only need to append at the end.

Definition at line 956 of file mpi_compute_index_owner_internal.h.

Member Data Documentation

◆ owned_indices

const IndexSet& Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload::owned_indices

The index space which describes the locally owned space.

Definition at line 567 of file mpi_compute_index_owner_internal.h.

◆ indices_to_look_up

const IndexSet& Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload::indices_to_look_up

The indices which are "ghosts" on a given rank and should be looked up in terms of their owner rank from owned_indices.

Definition at line 573 of file mpi_compute_index_owner_internal.h.

◆ comm

const MPI_Comm Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload::comm

The underlying MPI communicator.

Definition at line 578 of file mpi_compute_index_owner_internal.h.

◆ my_rank

const unsigned int Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload::my_rank

The present MPI rank.

Definition at line 583 of file mpi_compute_index_owner_internal.h.

◆ n_procs

const unsigned int Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload::n_procs

The total number of ranks participating in the MPI communicator comm.

Definition at line 589 of file mpi_compute_index_owner_internal.h.

◆ track_index_requests

const bool Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload::track_index_requests

Controls whether the origin of ghost owner should also be stored. If true, it will be added into requesters and can be queried by get_requesters().

Definition at line 596 of file mpi_compute_index_owner_internal.h.

◆ owning_ranks

std::vector<unsigned int>& Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload::owning_ranks

The result of the index owner computation: To each index contained in indices_to_look_up, this vector contains the MPI rank of the owner in owned_indices.

Definition at line 603 of file mpi_compute_index_owner_internal.h.

◆ requesters

std::vector<std::vector< std::pair<unsigned int, std::vector<std::pair<unsigned int, unsigned int> > > > > Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload::requesters

Keeps track of the origin of the requests. The layout of the data structure is as follows: The outermost vector has as many entries as Dictionary::actually_owning_rank_list and represents the information we should send back to the owners from the present dictionary entry. The second vector then collects a list of MPI ranks that have requested data, using the rank in the first pair entry and a list of index ranges as the second entry.

Definition at line 617 of file mpi_compute_index_owner_internal.h.

◆ dict

Dictionary Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload::dict

The dictionary handling the requests.

Definition at line 622 of file mpi_compute_index_owner_internal.h.

◆ indices_to_look_up_by_dict_rank

std::map<unsigned int, std::vector<types::global_dof_index> > Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload::indices_to_look_up_by_dict_rank

Array to collect the indices to look up, sorted by the rank in the dictionary.

Definition at line 629 of file mpi_compute_index_owner_internal.h.

◆ recv_indices

std::map<unsigned int, std::vector<unsigned int> > Utilities::MPI::internal::ComputeIndexOwner::ConsensusAlgorithmsPayload::recv_indices

The field where the indices for incoming data from the process are stored.

Definition at line 635 of file mpi_compute_index_owner_internal.h.


The documentation for this class was generated from the following file: