* @arg n number of columns
* @arg max_per_row maximum
* number of nonzero entries per row
- *
- * @arg optimize_diagonal store
- * diagonal entries first in row;
- * see optimize_diagonal(). This
- * takes effect for quadratic
- * matrices only.
*/
- ChunkSparsityPattern (const unsigned int m,
- const unsigned int n,
+ ChunkSparsityPattern (const types::global_dof_index m,
+ const types::global_dof_index n,
const unsigned int max_chunks_per_row,
+ const unsigned int chunk_size);
+
+ /**
+ * @deprecated This constructor is deprecated. Use the version
+ * without the last argument
+ */
+ ChunkSparsityPattern (const unsigned int m,
+ const unsigned int n,
+ const unsigned int max_chunks_per_row,
const unsigned int chunk_size,
- const bool optimize_diagonal = true);
+ const bool optimize_diagonal) DEAL_II_DEPRECATED;
/**
* Initialize a rectangular
* number of nonzero entries for
* each row. This vector must
* have one entry for each row.
- *
- * @arg optimize_diagonal store
- * diagonal entries first in row;
- * see optimize_diagonal(). This
- * takes effect for quadratic
- * matrices only.
*/
- ChunkSparsityPattern (const unsigned int m,
- const unsigned int n,
+ ChunkSparsityPattern (const types::global_dof_index m,
+ const types::global_dof_index n,
const std::vector<unsigned int> &row_lengths,
+ const unsigned int chunk_size);
+
+ /**
+ * @deprecated This constructor is deprecated. Use the version
+ * without the last argument
+ */
+ ChunkSparsityPattern (const unsigned int m,
+ const unsigned int n,
+ const std::vector<unsigned int> &row_lengths,
const unsigned int chunk_size,
- const bool optimize_diagonal = true);
+ const bool optimize_diagonal) DEAL_II_DEPRECATED;
/**
* Initialize a quadratic matrix
* number of nonzero entries for
* each row. This vector must
* have one entry for each row.
- *
- * @arg optimize_diagonal store
- * diagonal entries first in row;
- * see optimize_diagonal().
*/
- ChunkSparsityPattern (const unsigned int m,
+ ChunkSparsityPattern (const types::global_dof_index m,
+ const std::vector<unsigned int> &row_lengths,
+ const unsigned int chunk_size);
+
+ /**
+ * @deprecated This constructor is deprecated. Use the version
+ * without the last argument
+ */
+ ChunkSparsityPattern (const unsigned int m,
const std::vector<unsigned int> &row_lengths,
const unsigned int chunk_size,
- const bool optimize_diagonal = true);
+ const bool optimize_diagonal) DEAL_II_DEPRECATED;
/**
* Destructor.
* operations to the other
* <tt>reinit</tt> function.
*/
- void reinit (const unsigned int m,
- const unsigned int n,
+ void reinit (const types::global_dof_index m,
+ const types::global_dof_index n,
const unsigned int max_per_row,
+ const unsigned int chunk_size);
+
+ /**
+ * @deprecated This function is deprecated. Use the function
+ * without the last argument
+ */
+ void reinit (const unsigned int m,
+ const unsigned int n,
+ const unsigned int max_per_row,
const unsigned int chunk_size,
- const bool optimize_diagonal = true);
+ const bool optimize_diagonal) DEAL_II_DEPRECATED;
/**
* Reallocate memory for a matrix
* optimized access in relaxation
* methods of SparseMatrix.
*/
- void reinit (const unsigned int m,
- const unsigned int n,
+ void reinit (const types::global_dof_index m,
+ const types::global_dof_index n,
const std::vector<unsigned int> &row_lengths,
+ const unsigned int chunk_size);
+
+ /**
+ * @deprecated This function is deprecated. Use the function
+ * without the last argument
+ */
+ void reinit (const unsigned int m,
+ const unsigned int n,
+ const std::vector<unsigned int> &row_lengths,
const unsigned int chunk_size,
- const bool optimize_diagonal = true);
+ const bool optimize_diagonal) DEAL_II_DEPRECATED;
/**
* Same as above, but with a
* VectorSlice argument instead.
*/
- void reinit (const unsigned int m,
- const unsigned int n,
+ void reinit (const types::global_dof_index m,
+ const types::global_dof_index n,
const VectorSlice<const std::vector<unsigned int> > &row_lengths,
+ const unsigned int chunk_size);
+
+ /**
+ * @deprecated This function is deprecated. Use the function
+ * without the last argument
+ */
+ void reinit (const unsigned int m,
+ const unsigned int n,
+ const VectorSlice<const std::vector<unsigned int> > &row_lengths,
const unsigned int chunk_size,
- const bool optimize_diagonal = true);
+ const bool optimize_diagonal) DEAL_II_DEPRECATED;
/**
* This function compresses the sparsity
* pairs.
*/
template <typename ForwardIterator>
- void copy_from (const unsigned int n_rows,
- const unsigned int n_cols,
+ void copy_from (const types::global_dof_index n_rows,
+ const types::global_dof_index n_cols,
const ForwardIterator begin,
const ForwardIterator end,
+ const unsigned int chunk_size);
+
+ /**
+ * @deprecated This function is deprecated. Use the function
+ * without the last argument
+ */
+ template <typename ForwardIterator>
+ void copy_from (const unsigned int n_rows,
+ const unsigned int n_cols,
+ const ForwardIterator begin,
+ const ForwardIterator end,
const unsigned int chunk_size,
- const bool optimize_diagonal = true);
+ const bool optimize_diagonal) DEAL_II_DEPRECATED;
/**
* Copy data from an object of type
// $Id$
// Version: $Name$
//
--// Copyright (C) 2008, 2011, 2012 by the deal.II authors
++// Copyright (C) 2008, 2011, 2012, 2013 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
-ChunkSparsityPattern::ChunkSparsityPattern (const unsigned int m,
- const unsigned int n,
+ChunkSparsityPattern::ChunkSparsityPattern (const types::global_dof_index m,
+ const types::global_dof_index n,
const unsigned int max_per_row,
const unsigned int chunk_size,
- const bool optimize_diag)
+ const bool)
{
Assert (chunk_size > 0, ExcInvalidNumber (chunk_size));
void
-ChunkSparsityPattern::reinit (const unsigned int m,
- const unsigned int n,
+ChunkSparsityPattern::reinit (const types::global_dof_index m,
+ const types::global_dof_index n,
const unsigned int max_per_row,
const unsigned int chunk_size,
- const bool optimize_diag)
+ const bool)
+ {
+ reinit (m, n, max_per_row, chunk_size);
+ }
+
+
+ void
+ ChunkSparsityPattern::reinit (const unsigned int m,
+ const unsigned int n,
+ const unsigned int max_per_row,
+ const unsigned int chunk_size)
{
Assert (chunk_size > 0, ExcInvalidNumber (chunk_size));
void
ChunkSparsityPattern::reinit (
- const unsigned int m,
- const unsigned int n,
+ const types::global_dof_index m,
+ const types::global_dof_index n,
const VectorSlice<const std::vector<unsigned int> > &row_lengths,
const unsigned int chunk_size,
- const bool optimize_diag)
+ const bool)
+ {
+ reinit (m, n, row_lengths, chunk_size);
+ }
+
+
+ void
+ ChunkSparsityPattern::reinit (
+ const unsigned int m,
+ const unsigned int n,
+ const VectorSlice<const std::vector<unsigned int> > &row_lengths,
+ const unsigned int chunk_size)
{
Assert (row_lengths.size() == m, ExcInvalidNumber (m));
Assert (chunk_size > 0, ExcInvalidNumber (chunk_size));
void
ChunkSparsityPattern::reinit (
- const unsigned int m,
- const unsigned int n,
+ const types::global_dof_index m,
+ const types::global_dof_index n,
const std::vector<unsigned int> &row_lengths,
const unsigned int chunk_size,
- const bool optimize_diag)
+ const bool)
+ {
+ reinit (m, n, row_lengths, chunk_size);
+ }
+
+
+ void
+ ChunkSparsityPattern::reinit (
+ const unsigned int m,
+ const unsigned int n,
+ const std::vector<unsigned int> &row_lengths,
+ const unsigned int chunk_size)
{
Assert (chunk_size > 0, ExcInvalidNumber (chunk_size));