void
NavierStokesProjection<dim>::diffusion_step (const bool reinit_prec)
{
- pres_tmp.equ (-1., pres_n, -4./3., phi_n, 1./3., phi_n_minus_1);
+ pres_tmp = pres_n;
+ pres_tmp.sadd(-1., -4./3., phi_n, 1./3., phi_n_minus_1);
assemble_advection_term();
/**
* Simple vector addition, equal to the <tt>operator +=</tt>.
*
- * This function is deprecated use the <tt>operator +=</tt> instead.
+ * @deprecated Use the <tt>operator +=</tt> instead.
*/
void add (const Vector<Number> &V) DEAL_II_DEPRECATED;
/**
* Scaling and multiple addition. <tt>*this = s*(*this)+a*V + b*W +
* c*X</tt>.
+ *
+ * This function is deprecated.
*/
void sadd (const Number s,
const Number a,
const Number b,
const Vector<Number> &W,
const Number c,
- const Vector<Number> &X);
+ const Vector<Number> &X) DEAL_II_DEPRECATED;
/**
* Scale each element of the vector by a constant value.
/**
* Assignment <tt>*this = a*u + b*v + b*w</tt>.
+ *
+ * This function is deprecated.
*/
void equ (const Number a, const Vector<Number> &u,
const Number b, const Vector<Number> &v,
- const Number c, const Vector<Number> &w);
+ const Number c, const Vector<Number> &w) DEAL_II_DEPRECATED;
/**
* Compute the elementwise ratio of the two given vectors, that is let
/**
* Simple vector addition, equal to the <tt>operator +=</tt>.
*
- * This function is deprecated use += instead.
+ * @deprecated Use the <tt>operator +=</tt> instead.
*/
void add (const VectorBase &V) DEAL_II_DEPRECATED;
/**
* Scaling and multiple addition. <tt>*this = s*(*this)+a*V + b*W +
* c*X</tt>.
+ *
+ * This function is deprecated.
*/
void sadd (const PetscScalar s,
const PetscScalar a,
const PetscScalar b,
const VectorBase &W,
const PetscScalar c,
- const VectorBase &X);
+ const VectorBase &X) DEAL_II_DEPRECATED;
/**
* Scale each element of this vector by the corresponding element in the
/**
* Scaling and multiple addition. <tt>*this = s*(*this) + a*V + b*W +
* c*X</tt>.
+ *
+ * This function is deprecated.
*/
void sadd (const TrilinosScalar s,
const TrilinosScalar a,
const TrilinosScalar b,
const VectorBase &W,
const TrilinosScalar c,
- const VectorBase &X);
+ const VectorBase &X) DEAL_II_DEPRECATED;
/**
* Scale each element of this vector by the corresponding element in the
/**
* Simple vector addition, equal to the <tt>operator +=</tt>.
*
- * This function is deprecated use the <tt>operator +=</tt> instead.
+ * @deprecate Use the <tt>operator +=</tt> instead.
*
* @dealiiOperationIsMultithreaded
*/
* Scaling and multiple addition. <tt>*this = s*(*this)+a*V + b*W +
* c*X</tt>.
*
+ * This function is deprecated.
+ *
* @dealiiOperationIsMultithreaded
*/
void sadd (const Number s,
const Number b,
const Vector<Number> &W,
const Number c,
- const Vector<Number> &X);
+ const Vector<Number> &X) DEAL_II_DEPRECATED;
/**
* Scale each element of the vector by a constant value.
/**
* Assignment <tt>*this = a*u + b*v + b*w</tt>.
*
+ * This function is deprecated.
+ *
* @dealiiOperationIsMultithreaded
*/
void equ (const Number a, const Vector<Number> &u,
const Number b, const Vector<Number> &v,
- const Number c, const Vector<Number> &w);
+ const Number c, const Vector<Number> &w) DEAL_II_DEPRECATED;
/**
* Compute the elementwise ratio of the two given vectors, that is let
* manipulator, if printing across. If @p across is @p true then the vector
* is printed in a line, while if @p false then the elements are printed on
* a separate line each.
+ *
+ * This function is deprecated.
*/
void print (LogStream &out,
const unsigned int width = 6,
- const bool across = true) const;
+ const bool across = true) const DEAL_II_DEPRECATED;
/**
* Write the vector en bloc to a file. This is done in a binary mode, so the