const size_type max_chunks_per_row,
const size_type chunk_size);
- /**
- * @deprecated This constructor is deprecated. Use the version without the
- * last argument
- */
- ChunkSparsityPattern (const size_type m,
- const size_type n,
- const size_type max_chunks_per_row,
- const size_type chunk_size,
- const bool optimize_diagonal) DEAL_II_DEPRECATED;
-
/**
* Initialize a rectangular matrix.
*
const std::vector<size_type> &row_lengths,
const size_type chunk_size);
- /**
- * @deprecated This constructor is deprecated. Use the version without the
- * last argument
- */
- ChunkSparsityPattern (const size_type m,
- const size_type n,
- const std::vector<size_type> &row_lengths,
- const size_type chunk_size,
- const bool optimize_diagonal) DEAL_II_DEPRECATED;
-
/**
* Initialize a quadratic matrix of dimension <tt>n</tt> with at most
* <tt>max_per_row</tt> nonzero entries per row.
const std::vector<size_type> &row_lengths,
const size_type chunk_size);
- /**
- * @deprecated This constructor is deprecated. Use the version without the
- * last argument
- */
- ChunkSparsityPattern (const size_type m,
- const std::vector<size_type> &row_lengths,
- const size_type chunk_size,
- const bool optimize_diagonal) DEAL_II_DEPRECATED;
-
/**
* Destructor.
*/
const size_type max_per_row,
const size_type chunk_size);
- /**
- * @deprecated This function is deprecated. Use the function without the
- * last argument
- */
- void reinit (const size_type m,
- const size_type n,
- const size_type max_per_row,
- const size_type chunk_size,
- const bool optimize_diagonal) DEAL_II_DEPRECATED;
-
/**
* Reallocate memory for a matrix of size <tt>m x n</tt>. The number of
* entries for each row is taken from the array <tt>row_lengths</tt> which
const std::vector<size_type> &row_lengths,
const size_type chunk_size);
- /**
- * @deprecated This function is deprecated. Use the function without the
- * last argument
- */
- void reinit (const size_type m,
- const size_type n,
- const std::vector<size_type > &row_lengths,
- const size_type chunk_size,
- const bool optimize_diagonal) DEAL_II_DEPRECATED;
-
/**
* Same as above, but with a VectorSlice argument instead.
*/
const VectorSlice<const std::vector<size_type> > &row_lengths,
const size_type chunk_size);
- /**
- * @deprecated This function is deprecated. Use the function without the
- * last argument
- */
- void reinit (const size_type m,
- const size_type n,
- const VectorSlice<const std::vector<size_type> > &row_lengths,
- const size_type chunk_size,
- const bool optimize_diagonal) DEAL_II_DEPRECATED;
-
/**
* This function compresses the sparsity structure that this object
* represents. It does so by eliminating unused entries and sorting the
const ForwardIterator end,
const size_type chunk_size);
- /**
- * @deprecated This function is deprecated. Use the function without the
- * last argument
- */
- template <typename ForwardIterator>
- void copy_from (const size_type n_rows,
- const size_type n_cols,
- const ForwardIterator begin,
- const ForwardIterator end,
- const size_type chunk_size,
- const bool optimize_diagonal) DEAL_II_DEPRECATED;
-
/**
* Copy data from an object of type CompressedSparsityPattern,
* CompressedSetSparsityPattern or CompressedSimpleSparsityPattern. Previous
void copy_from (const SparsityType &csp,
const size_type chunk_size);
- /**
- * @deprecated This function is deprecated. Use the function without the
- * last argument
- */
- template <typename SparsityType>
- void copy_from (const SparsityType &csp,
- const size_type chunk_size,
- const bool optimize_diagonal) DEAL_II_DEPRECATED;
-
/**
* Take a full matrix and use its nonzero entries to generate a sparse
* matrix entry pattern for this object.
void copy_from (const FullMatrix<number> &matrix,
const size_type chunk_size);
- /**
- * @deprecated This function is deprecated. Use the function without the
- * last argument
- */
- template <typename number>
- void copy_from (const FullMatrix<number> &matrix,
- const size_type chunk_size,
- const bool optimize_diagonal) DEAL_II_DEPRECATED;
-
/**
* Set the sparsity pattern of the chunk sparsity pattern to be given by
* <tt>chunk_size*chunksize</tt> blocks of the sparsity pattern for chunks
*/
bool is_compressed () const;
- /**
- * Determine whether the matrix uses the special convention for quadratic
- * matrices that the diagonal entries are stored first in each row.
- *
- * @deprecated The function always returns true if the matrix is square and
- * false if it is not.
- */
- bool optimize_diagonal () const DEAL_II_DEPRECATED;
-
/**
* Return whether this object stores only those entries that have been added
* explicitly, or if the sparsity pattern contains elements that have been
-inline
-bool
-ChunkSparsityPattern::optimize_diagonal () const
-{
- return sparsity_pattern.store_diagonal_first_in_row;
-}
-
-
-
-template <typename ForwardIterator>
-inline
-void
-ChunkSparsityPattern::copy_from (const size_type n_rows,
- const size_type n_cols,
- const ForwardIterator begin,
- const ForwardIterator end,
- const size_type chunk_size,
- const bool)
-{
- copy_from (n_rows, n_cols, begin, end, chunk_size);
-}
-
-
-
template <typename ForwardIterator>
void
ChunkSparsityPattern::copy_from (const size_type n_rows,
-ChunkSparsityPattern::ChunkSparsityPattern (const size_type m,
- const size_type n,
- const size_type max_per_row,
- const size_type chunk_size,
- const bool)
-{
- Assert (chunk_size > 0, ExcInvalidNumber (chunk_size));
-
- reinit (m,n,max_per_row, chunk_size);
-}
-
-
ChunkSparsityPattern::ChunkSparsityPattern (const size_type m,
const size_type n,
const size_type max_per_row,
-ChunkSparsityPattern::ChunkSparsityPattern (
- const size_type m,
- const size_type n,
- const std::vector<size_type> &row_lengths,
- const size_type chunk_size,
- const bool)
-{
- Assert (chunk_size > 0, ExcInvalidNumber (chunk_size));
-
- reinit (m, n, row_lengths, chunk_size);
-}
-
-
-
ChunkSparsityPattern::ChunkSparsityPattern (
const size_type m,
const size_type n,
-ChunkSparsityPattern::ChunkSparsityPattern (
- const size_type m,
- const std::vector<size_type> &row_lengths,
- const size_type chunk_size,
- const bool)
-{
- Assert (chunk_size > 0, ExcInvalidNumber (chunk_size));
-
- reinit (m, m, row_lengths, chunk_size);
-}
-
-
-
ChunkSparsityPattern::ChunkSparsityPattern (
const size_type m,
const std::vector<size_type > &row_lengths,
-void
-ChunkSparsityPattern::reinit (const size_type m,
- const size_type n,
- const size_type max_per_row,
- const size_type chunk_size,
- const bool)
-{
- reinit (m, n, max_per_row, chunk_size);
-}
-
-
void
ChunkSparsityPattern::reinit (const size_type m,
const size_type n,
-void
-ChunkSparsityPattern::reinit (
- const size_type m,
- const size_type n,
- const VectorSlice<const std::vector<size_type> > &row_lengths,
- const size_type chunk_size,
- const bool)
-{
- reinit (m, n, row_lengths, chunk_size);
-}
-
-
void
ChunkSparsityPattern::reinit (
const size_type m,
-template <typename SparsityType>
-void
-ChunkSparsityPattern::copy_from (const SparsityType &csp,
- const size_type chunk_size,
- const bool)
-{
- copy_from (csp, chunk_size);
-}
-
-
-
namespace internal
{
namespace
-template <typename number>
-void ChunkSparsityPattern::copy_from (const FullMatrix<number> &matrix,
- const size_type chunk_size,
- const bool)
-{
- copy_from (matrix, chunk_size);
-}
-
-
template <typename number>
void ChunkSparsityPattern::copy_from (const FullMatrix<number> &matrix,
const size_type chunk_size)
}
-void
-ChunkSparsityPattern::reinit (
- const size_type m,
- const size_type n,
- const std::vector<size_type> &row_lengths,
- const size_type chunk_size,
- const bool)
-{
- reinit (m, n, row_lengths, chunk_size);
-}
-
void
ChunkSparsityPattern::reinit (
// explicit instantiations
template
-void ChunkSparsityPattern::copy_from<SparsityPattern> (const SparsityPattern &,
- const size_type,
- const bool);
-template
-void ChunkSparsityPattern::copy_from<CompressedSparsityPattern> (const CompressedSparsityPattern &,
- const size_type ,
- const bool);
-template
-void ChunkSparsityPattern::copy_from<CompressedSetSparsityPattern> (const CompressedSetSparsityPattern &,
- const size_type ,
- const bool);
-template
-void ChunkSparsityPattern::copy_from<CompressedSimpleSparsityPattern> (const CompressedSimpleSparsityPattern &,
- const size_type ,
- const bool);
-template
void ChunkSparsityPattern::copy_from<CompressedSparsityPattern> (const CompressedSparsityPattern &,
const size_type);
template
const unsigned int,
const bool);
template
-void ChunkSparsityPattern::copy_from<float> (const FullMatrix<float> &,
- const size_type ,
- const bool);
-template
-void ChunkSparsityPattern::copy_from<double> (const FullMatrix<double> &,
- const size_type ,
- const bool);
-template
void ChunkSparsityPattern::copy_from<float> (const FullMatrix<float> &,
const size_type);
template