15#ifndef dealii_index_set_h
16#define dealii_index_set_h
29#include <boost/container/small_vector.hpp>
35#ifdef DEAL_II_WITH_TRILINOS
36# include <Epetra_Map.h>
37# ifdef DEAL_II_TRILINOS_WITH_TPETRA
38# include <Tpetra_Map.hpp>
42#ifdef DEAL_II_WITH_PETSC
137#ifdef DEAL_II_WITH_TRILINOS
139# ifdef DEAL_II_TRILINOS_WITH_TPETRA
143 template <
typename NodeType>
146 const Tpetra::Map<int, types::signed_global_dof_index, NodeType>> &map);
152 explicit IndexSet(
const Epetra_BlockMap &map);
225 template <
typename ForwardIterator>
454 std::vector<IndexSet>
456 const std::vector<types::global_dof_index> &n_indices_per_block)
const;
493 DEAL_II_DEPRECATED_EARLY
505 DEAL_II_DEPRECATED_EARLY
517 std::vector<size_type>
542 template <
typename VectorType>
560 template <
typename StreamType>
562 print(StreamType &out)
const;
569 write(std::ostream &out)
const;
576 read(std::istream &in);
592#ifdef DEAL_II_WITH_TRILINOS
625# ifdef DEAL_II_TRILINOS_WITH_TPETRA
629 Tpetra::Map<int, types::signed_global_dof_index, NodeType>
636 Teuchos::RCP<Tpetra::Map<int, types::signed_global_dof_index, NodeType>>
642#ifdef DEAL_II_WITH_PETSC
657 <<
"The global index " << arg1
658 <<
" is not an element of this set.");
665 template <
class Archive>
667 serialize(Archive &ar,
const unsigned int version);
1058 friend inline bool {
…};
1088 return sizeof(
Range);
1096 template <
class Archive>
1098 serialize(Archive &ar,
const unsigned int version);
1190 boost::container::small_vector<std::pair<size_type, size_type>, 200>
1192 const bool ranges_are_sorted);
1232 , range_idx(range_idx)
1242 , range_idx(
numbers::invalid_dof_index)
1249 : index_set(other.index_set)
1250 , range_idx(other.range_idx)
1262 return index_set->ranges[range_idx].end - index_set->ranges[range_idx].begin;
1270 return index_set !=
nullptr && range_idx < index_set->n_intervals();
1279 return {index_set, range_idx, index_set->ranges[range_idx].begin};
1290 if (range_idx < index_set->
ranges.size() - 1)
1291 return {index_set, range_idx + 1, index_set->ranges[range_idx + 1].begin};
1293 return index_set->end();
1303 return index_set->ranges[range_idx].end - 1;
1326 "Can not compare accessors pointing to different IndexSets"));
1338 "Can not compare accessors pointing to different IndexSets"));
1350 "Impossible to advance an IndexSet::IntervalIterator that is invalid"));
1354 if (range_idx >= index_set->ranges.size())
1364 : accessor(idxset, range_idx)
1429 return !(*
this == other);
1449 "Can not compare iterators belonging to different IndexSets"));
1452 accessor.index_set->ranges.size() :
1456 accessor.index_set->ranges.size() :
1460 return static_cast<int>(lhs - rhs);
1462 return -
static_cast<int>(rhs - lhs);
1474 , range_idx(range_idx)
1479 "Invalid range index for IndexSet::ElementIterator constructor."));
1484 "Invalid index argument for IndexSet::ElementIterator constructor."));
1491 , range_idx(
numbers::invalid_dof_index)
1492 , idx(
numbers::invalid_dof_index)
1502 (range_idx < index_set->
ranges.size() &&
1503 idx < index_set->
ranges[range_idx].end),
1506 return (range_idx < index_set->
ranges.size() &&
1507 idx < index_set->
ranges[range_idx].end);
1518 "Impossible to dereference an IndexSet::ElementIterator that is invalid"));
1530 "Can not compare iterators belonging to different IndexSets"));
1531 return range_idx == other.
range_idx && idx == other.
idx;
1542 "Impossible to advance an IndexSet::ElementIterator that is invalid"));
1543 if (idx < index_set->
ranges[range_idx].
end)
1546 if (idx == index_set->ranges[range_idx].end)
1549 if (range_idx < index_set->
ranges.size() - 1)
1552 idx = index_set->ranges[range_idx].begin;
1588 return !(*
this == other);
1599 "Can not compare iterators belonging to different IndexSets"));
1606inline std::ptrdiff_t
1612 "Can not compare iterators belonging to different IndexSets"));
1615 if (!(*
this < other))
1616 return -(other - *
this);
1625 std::ptrdiff_t c = index_set->ranges[range_idx].end - idx;
1629 range < index_set->ranges.size() && range <= other.
range_idx;
1631 c += index_set->ranges[range].end - index_set->ranges[range].begin;
1634 other.
range_idx < index_set->ranges.size() ||
1637 "Inconsistent iterator state. Did you invalidate iterators by modifying the IndexSet?"));
1642 c -= index_set->ranges[other.
range_idx].end - other.
idx;
1677 : is_compressed(true)
1678 , index_space_size(
size)
1679 , largest_range(
numbers::invalid_unsigned_int)
1685 : ranges(std::move(is.ranges))
1686 , is_compressed(is.is_compressed)
1687 , index_space_size(is.index_space_size)
1688 , largest_range(is.largest_range)
1691 is.is_compressed =
true;
1692 is.index_space_size = 0;
1703 ranges = std::move(is.ranges);
1704 is_compressed = is.is_compressed;
1705 index_space_size = is.index_space_size;
1706 largest_range = is.largest_range;
1709 is.is_compressed =
true;
1710 is.index_space_size = 0;
1725 return {
this, 0,
ranges[0].begin};
1778 ExcMessage(
"This function can only be called if the current "
1779 "object does not yet contain any elements."));
1840template <
typename ForwardIterator>
1852 boost::container::small_vector<std::pair<size_type, size_type>, 200>
1854 bool ranges_are_sorted =
true;
1855 for (ForwardIterator p =
begin; p !=
end;)
1867 ForwardIterator q = p;
1869 while ((q !=
end) && (*q == *p))
1877 while ((q !=
end) && (
static_cast<size_type>(*q) == end_index))
1880 while ((q !=
end) && (
static_cast<size_type>(*q) == end_index))
1887 tmp_ranges.emplace_back(begin_index, end_index);
1895 if ((p !=
end) && (
static_cast<size_type>(*p) < end_index))
1896 ranges_are_sorted =
false;
1907 if (
ranges.empty() ==
false)
1916 else if (
ranges.size() > 1)
1931 return (
ranges.size() <= 1);
1960 for (
const auto &range :
ranges)
1961 s += (range.end - range.begin);
1985 const std::vector<Range>::const_iterator main_range =
1988 return main_range->nth_index_in_set;
2003 if (n >= main_range->nth_index_in_set &&
2005 return main_range->begin + (n - main_range->nth_index_in_set);
2030 else if (
ranges.size() > 1)
2044 return (is.
size() == 0);
2046 return (
size() == 0);
2065 return (is.
size() != 0);
2067 return (
size() != 0);
2080template <
typename Vector>
2088 std::fill(vector.
begin(), vector.
end(), 0);
2092 for (
const auto &range :
ranges)
2093 for (
size_type i = range.begin; i < range.end; ++i)
2099template <
typename StreamType>
2105 std::vector<Range>::const_iterator p;
2108 if (p->end - p->begin == 1)
2111 out <<
'[' << p->begin <<
',' << p->end - 1 <<
']';
2116 out <<
'}' << std::endl;
2121template <
class Archive>
2130template <
class Archive>
size_type operator*() const
bool operator==(const ElementIterator &) const
ElementIterator(const IndexSet *idxset, const size_type range_idx, const size_type index)
std::ptrdiff_t difference_type
ElementIterator & operator++()
bool operator<(const ElementIterator &) const
bool operator!=(const ElementIterator &) const
std::ptrdiff_t operator-(const ElementIterator &p) const
std::forward_iterator_tag iterator_category
const IndexSet * index_set
ElementIterator end() const
size_type n_elements() const
bool operator==(const IntervalAccessor &other) const
IntervalAccessor & operator=(const IntervalAccessor &other)
bool operator<(const IntervalAccessor &other) const
IntervalAccessor(const IndexSet *idxset, const size_type range_idx)
const IndexSet * index_set
ElementIterator begin() const
std::ptrdiff_t difference_type
const IntervalAccessor & operator*() const
IntervalIterator(const IntervalIterator &other)=default
bool operator==(const IntervalIterator &) const
int operator-(const IntervalIterator &p) const
bool operator<(const IntervalIterator &) const
std::forward_iterator_tag iterator_category
IntervalIterator & operator=(const IntervalIterator &other)=default
IntervalIterator & operator++()
const IntervalAccessor * operator->() const
IntervalAccessor accessor
bool operator!=(const IntervalIterator &) const
bool is_subset_of(const IndexSet &other) const
bool is_element_binary_search(const size_type local_index) const
size_type index_within_set_binary_search(const size_type global_index) const
IS make_petsc_is(const MPI_Comm communicator=MPI_COMM_WORLD) const
bool is_ascending_and_one_to_one(const MPI_Comm communicator) const
bool is_contiguous() const
unsigned int n_intervals() const
Tpetra::Map< int, types::signed_global_dof_index, NodeType > make_tpetra_map(const MPI_Comm communicator=MPI_COMM_WORLD, const bool overlapping=false) const
IndexSet(const IndexSet &)=default
IntervalIterator end_intervals() const
ElementIterator at(const size_type global_index) const
void fill_index_vector(std::vector< size_type > &indices) const
size_type index_within_set(const size_type global_index) const
std::vector< IndexSet > split_by_block(const std::vector< types::global_dof_index > &n_indices_per_block) const
size_type n_elements() const
bool operator==(const IndexSet &is) const
void add_range_lower_bound(const Range &range)
bool is_element(const size_type index) const
void serialize(Archive &ar, const unsigned int version)
ElementIterator begin() const
void set_size(const size_type size)
bool operator!=(const IndexSet &is) const
void read(std::istream &in)
Epetra_Map make_trilinos_map(const MPI_Comm communicator=MPI_COMM_WORLD, const bool overlapping=false) const
size_type largest_range_starting_index() const
void add_index(const size_type index)
void write(std::ostream &out) const
void block_read(std::istream &in)
void add_ranges_internal(boost::container::small_vector< std::pair< size_type, size_type >, 200 > &tmp_ranges, const bool ranges_are_sorted)
IntervalIterator begin_intervals() const
IndexSet & operator=(const IndexSet &)=default
void fill_binary_vector(VectorType &vector) const
std::vector< Range > ranges
void subtract_set(const IndexSet &other)
ElementIterator end() const
Threads::Mutex compress_mutex
IndexSet complete_index_set(const IndexSet::size_type N)
size_type index_space_size
void block_write(std::ostream &out) const
IndexSet get_view(const size_type begin, const size_type end) const
void add_range(const size_type begin, const size_type end)
size_type nth_index_in_set(const size_type local_index) const
std::size_t memory_consumption() const
void print(StreamType &out) const
size_type nth_index_in_set_binary_search(const size_type local_index) const
std::vector< size_type > get_index_vector() const
Teuchos::RCP< Tpetra::Map< int, types::signed_global_dof_index, NodeType > > make_tpetra_map_rcp(const MPI_Comm communicator=MPI_COMM_WORLD, const bool overlapping=false) const
types::global_dof_index size_type
void add_indices(const ForwardIterator &begin, const ForwardIterator &end)
IndexSet operator&(const IndexSet &is) const
virtual size_type size() const override
#define DEAL_II_DEPRECATED
#define DEAL_II_NAMESPACE_OPEN
constexpr bool running_in_debug_mode()
#define DEAL_II_NAMESPACE_CLOSE
#define Assert(cond, exc)
static ::ExceptionBase & ExcIndexNotPresent(size_type arg1)
#define AssertIndexRange(index, range)
static ::ExceptionBase & ExcInternalError()
static ::ExceptionBase & ExcDimensionMismatch(std::size_t arg1, std::size_t arg2)
#define DeclException1(Exception1, type1, outsequence)
static ::ExceptionBase & ExcMessage(std::string arg1)
Tpetra::KokkosCompat::KokkosDeviceWrapperNode< typename MemorySpace::kokkos_space::execution_space, typename MemorySpace::kokkos_space > NodeType
constexpr types::global_dof_index invalid_dof_index
constexpr unsigned int invalid_unsigned_int
unsigned int global_dof_index
static bool end_compare(const IndexSet::Range &x, const IndexSet::Range &y)
static bool nth_index_compare(const IndexSet::Range &x, const IndexSet::Range &y)
friend bool operator==(const Range &range_1, const Range &range_2)
size_type nth_index_in_set
static std::size_t memory_consumption()
void serialize(Archive &ar, const unsigned int version)
friend bool operator<(const Range &range_1, const Range &range_2)
void advance(std::tuple< I1, I2 > &t, const unsigned int n)