17 #include <deal.II/lac/chunk_sparsity_pattern.h> 18 #include <deal.II/lac/dynamic_sparsity_pattern.h> 19 #include <deal.II/lac/full_matrix.h> 22 DEAL_II_NAMESPACE_OPEN
34 , chunk_size(s.chunk_size)
35 , sparsity_pattern(s.sparsity_pattern)
39 "This constructor can only be called if the provided argument " 40 "is the sparsity pattern for an empty matrix. This constructor can " 41 "not be used to copy-construct a non-empty sparsity pattern."));
63 const std::vector<size_type> &row_lengths,
84 const std::vector<size_type> &row_lengths,
99 "This operator can only be called if the provided argument " 100 "is the sparsity pattern for an empty matrix. This operator can " 101 "not be used to copy a non-empty sparsity pattern."));
104 ExcMessage(
"This operator can only be called if the current object is " 124 const std::vector<size_type> row_lengths(m, max_per_row);
157 std::vector<unsigned int> chunk_row_lengths(m_chunks, 0);
159 chunk_row_lengths[i /
chunk_size] += row_lengths[i];
164 if (m != n && m_chunks == n_chunks)
165 for (
unsigned int i = 0; i < m_chunks; ++i)
166 ++chunk_row_lengths[i];
181 template <
typename SparsityPatternType>
205 for (
size_type row = 0; row < dsp.n_rows(); ++row)
212 for (
typename SparsityPatternType::iterator col_num = dsp.begin(row);
213 col_num != dsp.end(row);
215 temporary_sp.
add(reduced_row, col_num->column() /
chunk_size);
223 template <
typename number>
234 std::vector<size_type> entries_per_row(matrix.m(), 0);
235 for (
size_type row = 0; row < matrix.m(); ++row)
237 for (
size_type col = 0; col < matrix.n(); ++col)
238 if (matrix(row, col) != 0)
239 ++entries_per_row[row];
241 if ((matrix.m() == matrix.n()) && (matrix(row, row) == 0))
242 ++entries_per_row[row];
248 for (
size_type row = 0; row < matrix.m(); ++row)
249 for (
size_type col = 0; col < matrix.n(); ++col)
250 if (matrix(row, col) != 0)
262 const std::vector<size_type> &row_lengths,
276 template <
typename SparsityPatternType>
293 template <
typename Sparsity>
297 const Sparsity &sparsity_pattern_for_chunks,
301 Assert(m > (sparsity_pattern_for_chunks.n_rows() - 1) * chunk_size_in &&
302 m <= sparsity_pattern_for_chunks.n_rows() * chunk_size_in,
303 ExcMessage(
"Number of rows m is not compatible with chunk size " 304 "and number of rows in sparsity pattern for the chunks."));
305 Assert(n > (sparsity_pattern_for_chunks.n_cols() - 1) * chunk_size_in &&
306 n <= sparsity_pattern_for_chunks.n_cols() * chunk_size_in,
308 "Number of columns m is not compatible with chunk size " 309 "and number of columns in sparsity pattern for the chunks."));
386 for (; p !=
end; ++p)
477 out <<
']' << std::endl;
512 << -static_cast<signed int>(i *
chunk_size + e) << std::endl;
597 ChunkSparsityPattern::copy_from<DynamicSparsityPattern>(
601 ChunkSparsityPattern::create_from<SparsityPattern>(
const size_type,
607 ChunkSparsityPattern::create_from<DynamicSparsityPattern>(
620 DEAL_II_NAMESPACE_CLOSE
void block_write(std::ostream &out) const
void block_write(std::ostream &out) const
void copy_from(const size_type n_rows, const size_type n_cols, const ForwardIterator begin, const ForwardIterator end, const size_type chunk_size)
std::size_t memory_consumption() const
static ::ExceptionBase & ExcEmptyObject()
static ::ExceptionBase & ExcIO()
types::global_dof_index size_type
void add(const size_type i, const size_type j)
std::size_t memory_consumption() const
void block_read(std::istream &in)
bool exists(const size_type i, const size_type j) const
size_type bandwidth() const
void create_from(const size_type m, const size_type n, const Sparsity &sparsity_pattern_for_chunks, const size_type chunk_size, const bool optimize_diagonal=true)
#define AssertThrow(cond, exc)
void add(const size_type i, const size_type j)
static ::ExceptionBase & ExcIndexRange(int arg1, int arg2, int arg3)
static ::ExceptionBase & ExcInvalidNumber(size_type arg1)
SparsityPattern sparsity_pattern
std::unique_ptr< std::size_t[]> rowstart
size_type max_entries_per_row() const
virtual void reinit(const size_type m, const size_type n, const ArrayView< const unsigned int > &row_lengths) override
static ::ExceptionBase & ExcMessage(std::string arg1)
#define Assert(cond, exc)
void add(const size_type i, const size_type j)
size_type row_length(const size_type row) const
size_type n_nonzero_elements() const
void copy_from(const size_type n_rows, const size_type n_cols, const ForwardIterator begin, const ForwardIterator end)
static ::ExceptionBase & ExcInvalidIndex(size_type arg1, size_type arg2)
std::size_t n_nonzero_elements() const
ChunkSparsityPattern & operator=(const ChunkSparsityPattern &)
bool exists(const size_type i, const size_type j) const
std::unique_ptr< size_type[]> colnums
static ::ExceptionBase & ExcNotQuadratic()
bool stores_only_added_elements() const
void block_read(std::istream &in)
size_type bandwidth() const
static const size_type invalid_entry
bool stores_only_added_elements() const
void print(std::ostream &out) const
unsigned int row_length(const size_type row) const
void print_gnuplot(std::ostream &out) const
void reinit(const size_type m, const size_type n, const size_type max_per_row, const size_type chunk_size)
size_type max_entries_per_row() const