*/
void compress (::dealii::VectorOperation::values operation);
- /**
- * @deprecated: use compress() with VectorOperation instead.
- */
- void compress () DEAL_II_DEPRECATED;
-
/**
* Set the element (<i>i,j</i>) to @p value.
*
- inline
- void
- SparseMatrix::compress ()
- {
- compress(::dealii::VectorOperation::unknown);
- }
-
-
-
inline
SparseMatrix &
SparseMatrix::operator = (const double d)
return;
}
- // otherwise first flush Trilinos caches
- matrix->compress ();
-
// get a representation of the present
// row
int ncols;
{
Assert(sparsity_pattern.trilinos_sparsity_pattern().Filled() == true,
ExcMessage("The Trilinos sparsity pattern has not been compressed."));
- compress();
+ compress(VectorOperation::insert);
}
// In the end, the matrix needs to be compressed in order to be really
// ready.
- compress();
+ compress(VectorOperation::insert);
}
// In the end, the matrix needs to be compressed in order to be really
// ready.
- compress();
+ compress(VectorOperation::insert);
}
else
nonlocal_matrix.reset ();
- compress();
+ compress(VectorOperation::insert);
last_action = Zero;
}
else
nonlocal_matrix.reset();
- compress();
+ compress(VectorOperation::unknown);
}
&values[0], false);
}
- compress();
+ compress(VectorOperation::insert);
}
my_nonzeros*sizeof (TrilinosScalar));
}
- compress();
+ compress(VectorOperation::insert);
}
((last_action == Add) && (operation!=::dealii::VectorOperation::insert))
||
((last_action == Insert) && (operation!=::dealii::VectorOperation::add)),
- ExcMessage("operation and argument to compress() do not match"));
+ ExcMessage("Operation and argument to compress() do not match"));
}
// flush buffers
SparseMatrix::clear_rows (const std::vector<size_type> &rows,
const TrilinosScalar new_diag_value)
{
- compress();
for (size_type row=0; row<rows.size(); ++row)
clear_row(rows[row], new_diag_value);
// data, so we need to flush the
// buffers to make sure that the
// right data is used.
- compress();
+ compress(VectorOperation::insert);
}
GID, values[j]);
#endif
}
- transposed_mat.compress();
+ transposed_mat.compress(VectorOperation::insert);
ML_Operator_WrapEpetraCrsMatrix
(const_cast<Epetra_CrsMatrix *>(&transposed_mat.trilinos_matrix()),
A_,false);
// ---------------------------------------------------------------------
//
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
const unsigned int n_blocks = matrix.n_block_rows();
- matrix.compress();
-
// We need to find the subdivision
// into blocks for the boundary values.
// To this end, generate a vector of
Assert (local_range == solution.local_range(),
ExcInternalError());
- // we have to read and write from this
- // matrix (in this order). this will only
- // work if we compress the matrix first,
- // done here
- matrix.compress ();
-
// determine the first nonzero diagonal
// entry from within the part of the
// matrix that we can see. if we can't
}
// clean up
- matrix.compress ();
+ matrix.compress (VectorOperation::insert);
solution.compress (VectorOperation::insert);
right_hand_side.compress (VectorOperation::insert);
}
const unsigned int n_blocks = matrix.n_block_rows();
- matrix.compress();
-
// We need to find the subdivision
// into blocks for the boundary values.
// To this end, generate a vector of