* the compress() step).
*/
SparseMatrix (const Epetra_Map ¶llel_partitioning,
- const size_type n_max_entries_per_row = 0) DEAL_II_DEPRECATED;
+ const size_type n_max_entries_per_row = 0);
/**
* Same as before, but now set a value of nonzeros for each matrix row.
* respective SparseMatrix::reinit call considerably faster.
*/
SparseMatrix (const Epetra_Map ¶llel_partitioning,
- const std::vector<unsigned int> &n_entries_per_row) DEAL_II_DEPRECATED;
+ const std::vector<unsigned int> &n_entries_per_row);
/**
* This constructor is similar to the one above, but it now takes two
*/
SparseMatrix (const Epetra_Map &row_parallel_partitioning,
const Epetra_Map &col_parallel_partitioning,
- const size_type n_max_entries_per_row = 0) DEAL_II_DEPRECATED;
+ const size_type n_max_entries_per_row = 0);
/**
* This constructor is similar to the one above, but it now takes two
*/
SparseMatrix (const Epetra_Map &row_parallel_partitioning,
const Epetra_Map &col_parallel_partitioning,
- const std::vector<unsigned int> &n_entries_per_row) DEAL_II_DEPRECATED;
+ const std::vector<unsigned int> &n_entries_per_row);
/**
* This function is initializes the Trilinos Epetra matrix according to
template<typename SparsityType>
void reinit (const Epetra_Map ¶llel_partitioning,
const SparsityType &sparsity_pattern,
- const bool exchange_data = false) DEAL_II_DEPRECATED;
+ const bool exchange_data = false);
/**
* This function is similar to the other initialization function above,
void reinit (const Epetra_Map &row_parallel_partitioning,
const Epetra_Map &col_parallel_partitioning,
const SparsityType &sparsity_pattern,
- const bool exchange_data = false) DEAL_II_DEPRECATED;
+ const bool exchange_data = false);
/**
* This function initializes the Trilinos matrix using the deal.II sparse
const ::dealii::SparseMatrix<number> &dealii_sparse_matrix,
const double drop_tolerance=1e-13,
const bool copy_values=true,
- const ::dealii::SparsityPattern *use_this_sparsity=0) DEAL_II_DEPRECATED;
+ const ::dealii::SparsityPattern *use_this_sparsity=0);
/**
* This function is similar to the other initialization function with
const ::dealii::SparseMatrix<number> &dealii_sparse_matrix,
const double drop_tolerance=1e-13,
const bool copy_values=true,
- const ::dealii::SparsityPattern *use_this_sparsity=0) DEAL_II_DEPRECATED;
+ const ::dealii::SparsityPattern *use_this_sparsity=0);
//@}
/**
* @name Constructors and initialization using an IndexSet description
* sets the partitioning of the domain space of this matrix, i.e., the
* partitioning of the vectors this matrix has to be multiplied with.
*/
- const Epetra_Map &domain_partitioner () const DEAL_II_DEPRECATED;
+ const Epetra_Map &domain_partitioner () const;
/**
* Return a const reference to the underlying Trilinos Epetra_Map that
* partitioning of the vectors that are result from matrix-vector
* products.
*/
- const Epetra_Map &range_partitioner () const DEAL_II_DEPRECATED;
+ const Epetra_Map &range_partitioner () const;
/**
* Return a const reference to the underlying Trilinos Epetra_Map that
* sets the partitioning of the matrix rows. Equal to the partitioning of
* the range.
*/
- const Epetra_Map &row_partitioner () const DEAL_II_DEPRECATED;
+ const Epetra_Map &row_partitioner () const;
/**
* Return a const reference to the underlying Trilinos Epetra_Map that
* equal to the partitioner Epetra_Map for the domain because of overlap
* in the matrix.
*/
- const Epetra_Map &col_partitioner () const DEAL_II_DEPRECATED;
+ const Epetra_Map &col_partitioner () const;
//@}
/**