713 namespace ComputeIndexOwner
715 class FlexibleIndexStorage
718 using index_type =
unsigned int;
722 FlexibleIndexStorage(
const bool use_vector =
true);
725 reinit(
const bool use_vector,
726 const bool index_range_contiguous,
727 const std::size_t size);
730 fill(
const std::size_t start,
731 const std::size_t end,
732 const index_type &value);
735 operator[](
const std::size_t index);
738 operator[](
const std::size_t index)
const;
741 entry_has_been_set(
const std::size_t index)
const;
825 std::pair<types::global_dof_index, types::global_dof_index>
866 get_index_offset(
const unsigned int rank);
874 get_owning_rank_index(
const unsigned int rank_in_owned_indices,
875 const unsigned int guess = 0);
894 class ConsensusAlgorithmsPayload
897 using RequestType = std::vector<
898 std::pair<types::global_dof_index, types::global_dof_index>>;
899 using AnswerType = std::vector<unsigned int>;
904 ConsensusAlgorithmsPayload(
const IndexSet &owned_indices,
907 std::vector<unsigned int> &owning_ranks,
908 const bool track_index_requesters =
false);
966 std::vector<std::vector<
967 std::pair<
unsigned int,
977 std::map<
unsigned int,
978 std::pair<std::vector<types::global_dof_index>,
979 std::vector<unsigned int>>>
985 std::vector<unsigned int>
992 std::pair<types::global_dof_index, types::global_dof_index>>
993 create_request(
const unsigned int other_rank);
998 std::vector<unsigned int>
1000 const unsigned int other_rank,
1009 process_answer(
const unsigned int other_rank,
1010 const std::vector<unsigned int> &recv_buffer);
1027 std::map<unsigned int, IndexSet>
1045 append_index_origin(
1047 const unsigned int rank_of_request,
1048 const unsigned int rank_of_owner,
1049 unsigned int &owner_index_guess);
1064 Dictionary::get_index_offset(
const unsigned int rank)
1076 Dictionary::get_owning_rank_index(
1077 const unsigned int rank_in_owned_indices,
1078 const unsigned int guess)
1087 rank_in_owned_indices);
1095 const FlexibleIndexStorage::index_type
1096 FlexibleIndexStorage::invalid_index_value;
1100 FlexibleIndexStorage::FlexibleIndexStorage(
const bool use_vector)
1108 FlexibleIndexStorage::reinit(
const bool use_vector,
1109 const bool index_range_contiguous,
1110 const std::size_t
size)
1127 FlexibleIndexStorage::fill(
1128 const std::size_t start,
1129 const std::size_t end,
1130 const FlexibleIndexStorage::index_type &value)
1137 if (
data.empty() && end > start)
1149 std::fill(
data.begin() + start,
1161 std::fill(
data.begin() + start,
data.begin() + end, value);
1166 for (
auto i = start; i <
end; ++i)
1173 FlexibleIndexStorage::index_type &
1174 FlexibleIndexStorage::operator[](
const std::size_t index)
1193 FlexibleIndexStorage::entry_has_been_set(
const std::size_t index)
const
1220 std::map<
unsigned int,
1225 const auto owned_indices_size_actual =
1230 owned_indices_size_actual ==
1243 std::pair<types::global_dof_index, types::global_dof_index>
1244 index_range(*interval->begin(), interval->last() + 1);
1248 while (index_range.first != index_range.second)
1250 Assert(index_range.first < index_range.second,
1253 const unsigned int owner =
1254 dof_to_dict_rank(index_range.first);
1259 std::min(get_index_offset(owner + 1), index_range.second);
1281 dic_local_received += next_index - index_range.first;
1286 buffers[owner].emplace_back(index_range.first, next_index);
1288 index_range.first = next_index;
1292#ifdef DEAL_II_WITH_MPI
1294 std::vector<MPI_Request> request;
1308 static CollectiveMutex mutex;
1309 CollectiveMutex::ScopedLock lock(mutex,
comm);
1316 for (
const auto &rank_pair : buffers)
1318 request.push_back(MPI_Request());
1319 const int ierr = MPI_Isend(rank_pair.second.data(),
1320 rank_pair.second.size() * 2,
1330 while (this->locally_owned_size != dic_local_received)
1334 int ierr = MPI_Probe(MPI_ANY_SOURCE, mpi_tag,
comm, &status);
1339 ierr = MPI_Get_count(&status,
1344 const auto other_rank = status.MPI_SOURCE;
1350 std::pair<types::global_dof_index, types::global_dof_index>>
1351 buffer(number_amount / 2);
1352 ierr = MPI_Recv(buffer.data(),
1361 for (
auto interval : buffer)
1367 i < interval.second;
1385 dic_local_received += interval.second - interval.first;
1397 using RequestType = std::vector<
1398 std::pair<types::global_dof_index, types::global_dof_index>>;
1400 ConsensusAlgorithms::selector<RequestType>(
1403 std::vector<unsigned int> targets;
1404 targets.reserve(buffers.size());
1405 for (
const auto &rank_pair : buffers)
1406 targets.emplace_back(rank_pair.
first);
1412 [&buffers](
const unsigned int target_rank) -> RequestType {
1413 return buffers.at(target_rank);
1417 [&](
const unsigned int source_rank,
1418 const RequestType &request) ->
void {
1420 for (
auto interval : request)
1426 i < interval.second;
1432 "Multiple processes seem to own the same global index. "
1433 "A possible reason is that the sets of locally owned "
1434 "indices are not distinct."));
1435 Assert(interval.first < interval.second,
1441 "The specified interval is not handled by the current process."));
1464 if (request.size() > 0)
1466 const int ierr = MPI_Waitall(request.size(),
1468 MPI_STATUSES_IGNORE);
1475 (void)dic_local_received;
1506 ConsensusAlgorithmsPayload::ConsensusAlgorithmsPayload(
1525 std::vector<unsigned int>
1526 ConsensusAlgorithmsPayload::compute_targets()
1528 std::vector<unsigned int> targets;
1531 unsigned int index = 0;
1532 unsigned int owner_index_guess = 0;
1535 unsigned int other_rank =
dict.dof_to_dict_rank(i);
1539 dict.actually_owning_ranks[i -
dict.local_range.first];
1541 append_index_origin(i -
dict.local_range.first,
1548 if (targets.empty() || targets.back() != other_rank)
1549 targets.push_back(other_rank);
1551 indices.first.push_back(i);
1552 indices.second.push_back(index);
1565 std::vector<std::pair<types::global_dof_index, types::global_dof_index>>
1566 ConsensusAlgorithmsPayload::create_request(
1567 const unsigned int other_rank)
1570 std::pair<types::global_dof_index, types::global_dof_index>>
1576 is.add_indices(indices_i.begin(), indices_i.end());
1579 for (
auto interval = is.begin_intervals();
1580 interval != is.end_intervals();
1582 send_buffer.emplace_back(*interval->begin(), interval->last() + 1);
1589 std::vector<unsigned int>
1590 ConsensusAlgorithmsPayload::answer_request(
1591 const unsigned int other_rank,
1595 std::vector<unsigned int> request_buffer;
1597 unsigned int owner_index_guess = 0;
1598 for (
const auto &interval : buffer_recv)
1599 for (auto i = interval.
first; i < interval.second; ++i)
1601 const unsigned int actual_owner =
1602 dict.actually_owning_ranks[i -
dict.local_range.first];
1603 request_buffer.push_back(actual_owner);
1606 append_index_origin(i -
dict.local_range.first,
1612 return request_buffer;
1618 ConsensusAlgorithmsPayload::process_answer(
1619 const unsigned int other_rank,
1620 const std::vector<unsigned int> &recv_buffer)
1622 const auto &recv_indices =
1625 for (
unsigned int j = 0; j < recv_indices.size(); ++j)
1631 std::map<unsigned int, IndexSet>
1632 ConsensusAlgorithmsPayload::get_requesters()
1635 ExcMessage(
"Must enable index range tracking in "
1636 "constructor of ConsensusAlgorithmProcess"));
1638 std::map<unsigned int, ::IndexSet> requested_indices;
1640#ifdef DEAL_II_WITH_MPI
1642 static CollectiveMutex mutex;
1643 CollectiveMutex::ScopedLock lock(mutex,
comm);
1652 std::vector<MPI_Request> send_requests;
1663 std::vector<std::vector<types::global_dof_index>> send_data(
1665 for (
unsigned int i = 0; i <
requesters.size(); ++i)
1674 IndexSet &my_index_set = requested_indices[j.first];
1676 for (
const auto &interval : j.
second)
1677 my_index_set.add_range(index_offset + interval.
first,
1678 index_offset + interval.
second);
1685 send_data[i].push_back(j.first);
1686 send_data[i].push_back(j.second.size());
1687 for (
const auto &interval : j.
second)
1689 send_data[i].push_back(interval.first);
1690 send_data[i].push_back(interval.second);
1693 send_requests.push_back(MPI_Request());
1695 MPI_Isend(send_data[i].
data(),
1696 send_data[i].
size(),
1699 dict.actually_owning_rank_list[i],
1702 &send_requests.back());
1708 for (
unsigned int c = 0; c <
dict.n_dict_procs_in_owned_indices; ++c)
1712 int ierr = MPI_Probe(MPI_ANY_SOURCE, mpi_tag,
comm, &status);
1717 ierr = MPI_Get_count(
1719 Utilities::MPI::mpi_type_id_for_type<types::global_dof_index>,
1726 std::pair<types::global_dof_index, types::global_dof_index>>
1727 buffer(number_amount / 2);
1731 Utilities::MPI::mpi_type_id_for_type<types::global_dof_index>,
1741 dict.get_index_offset(status.MPI_SOURCE);
1742 unsigned int offset = 0;
1743 while (offset < buffer.size())
1749 for (
unsigned int i = offset + 1;
1750 i < offset + buffer[offset].second + 1;
1752 my_index_set.
add_range(index_offset + buffer[i].first,
1753 index_offset + buffer[i].second);
1758 IndexSet &index_set = requested_indices[buffer[offset].first];
1759 if (index_set.
size() == 0)
1763 offset += buffer[offset].second + 1;
1768 if (send_requests.size() > 0)
1770 const auto ierr = MPI_Waitall(send_requests.size(),
1771 send_requests.data(),
1772 MPI_STATUSES_IGNORE);
1779 for (
const auto &it : requested_indices)
1785 "The indices requested from the current "
1786 "MPI rank should be locally owned here!"));
1792 return requested_indices;
1798 ConsensusAlgorithmsPayload::append_index_origin(
1800 const unsigned int rank_of_request,
1801 const unsigned int rank_of_owner,
1802 unsigned int &owner_index_guess)
1809 dict.get_owning_rank_index(rank_of_owner, owner_index_guess);
1811 auto &request =
requesters[owner_index_guess];
1812 if (request.empty() || request.back().first != rank_of_request)
1813 request.emplace_back(
1816 std::pair<types::global_dof_index, types::global_dof_index>>());
1818 auto &intervals = request.back().second;
1819 if (intervals.empty() || intervals.back().second != index_within_dict)
1820 intervals.emplace_back(index_within_dict, index_within_dict + 1);
1822 ++intervals.back().second;