]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Deprecate the following functions: sadd with 5 arguments and equ with 4 arguments.
authorBruno Turcksin <bruno.turcksin@gmail.com>
Tue, 16 Jun 2015 15:32:36 +0000 (10:32 -0500)
committerBruno Turcksin <bruno.turcksin@gmail.com>
Tue, 16 Jun 2015 15:32:36 +0000 (10:32 -0500)
examples/step-14/step-14.cc
examples/step-35/step-35.cc
examples/step-44/step-44.cc
examples/step-52/step-52.cc
include/deal.II/lac/parallel_vector.h
include/deal.II/lac/petsc_vector_base.h
include/deal.II/lac/solver_bicgstab.h
include/deal.II/lac/trilinos_vector_base.h
include/deal.II/lac/vector.h
source/lac/trilinos_vector_base.cc

index 3a72348ea5a80f3839bb1dfeeadfde1383e56795..8bc7621cbbea029b388a6e1b427930ee43a8ec61 100644 (file)
@@ -2577,7 +2577,7 @@ namespace Step14
                           FaceIntegrals                                     &face_integrals) const
     {
       // Because of WorkStream, estimate_on_one_cell requires a CopyData object
-      // even if it is no used. The next line silence a warning about this unused
+      // even if it is no used. The next line silences a warning about this unused
       // variable.
       (void) copy_data;
 
index f7e526da06c79afae510265be3e42f8962f8666e..d89d0392942d89f8a9d16d03253e49d814606060 100644 (file)
@@ -982,7 +982,10 @@ namespace Step35
   NavierStokesProjection<dim>::interpolate_velocity()
   {
     for (unsigned int d=0; d<dim; ++d)
-      u_star[d].equ (2., u_n[d], -1, u_n_minus_1[d]);
+      {
+        u_star[d].equ (2., u_n[d]);
+        u_star[d].add (-1, u_n_minus_1[d]);
+      }
   }
 
 
@@ -1003,15 +1006,16 @@ namespace Step35
   void
   NavierStokesProjection<dim>::diffusion_step (const bool reinit_prec)
   {
-    pres_tmp = pres_n;
-    pres_tmp.sadd(-1., -4./3., phi_n, 1./3., phi_n_minus_1);
+    pres_tmp.equ (-1., pres_n);
+    pres_tmp.add (-4./3., phi_n, 1./3., phi_n_minus_1);
 
     assemble_advection_term();
 
     for (unsigned int d=0; d<dim; ++d)
       {
         force[d] = 0.;
-        v_tmp.equ (2./dt,u_n[d],-.5/dt,u_n_minus_1[d]);
+        v_tmp.equ (2./dt,u_n[d]);
+        v_tmp.add (-.5/dt,u_n_minus_1[d]);
         vel_Mass.vmult_add (force[d], v_tmp);
 
         pres_Diff[d].vmult_add (force[d], pres_tmp);
@@ -1239,7 +1243,8 @@ namespace Step35
           prec_mass.initialize (pres_Mass);
         pres_n = pres_tmp;
         prec_mass.solve (pres_n);
-        pres_n.sadd(1./Re, 1., pres_n_minus_1, 1., phi_n);
+        pres_n.sadd(1./Re, 1., pres_n_minus_1);
+        pres_n += phi_n;
         break;
       default:
         Assert (false, ExcNotImplemented());
index 5e77aa5577a34df4f1b835660f3fc4ea77753510..bf26553a97d0fd9a0cb3376f1c190024a37c4e59 100644 (file)
@@ -2663,7 +2663,8 @@ namespace Step44
       //      \mathsf{\mathbf{K}}^{-1}_{\widetilde{p} \widetilde{J}}
       //      \mathsf{\mathbf{F}}_{\widetilde{p}}
       //      $
-      A.block(J_dof).equ(1.0, system_rhs.block(J_dof), -1.0, B.block(J_dof));
+      A.block(J_dof).equ(1.0, system_rhs.block(J_dof));
+      A.block(J_dof).add(-1.0, B.block(J_dof));
       //      $
       //      \mathsf{\mathbf{A}}_{\widetilde{J}}
       //      =
index 47a9289be9a752454a7b04f9fa6582ba6cbf4b53..6740e4f3362c5f3cf61fc4a103655cec1dc08ec8 100644 (file)
@@ -351,6 +351,7 @@ namespace Step52
                                                     const double tau,
                                                     const Vector<double> &y)
   {
+    (void) time;
     SparseDirectUMFPACK inverse_mass_minus_tau_Jacobian;
 
     mass_minus_tau_Jacobian.copy_from(mass_matrix);
index bca43440d8e6fff12091c524537a0a86519b8030..d2e78f7c92dff87fb53e886434e64f4f7e1fca17 100644 (file)
@@ -858,12 +858,14 @@ namespace parallel
 
       /**
        * Scaling and multiple addition.
+       *
+       * This function is deprecated.
        */
       void sadd (const Number          s,
                  const Number          a,
                  const Vector<Number> &V,
                  const Number          b,
-                 const Vector<Number> &W);
+                 const Vector<Number> &W) DEAL_II_DEPRECATED;
 
       /**
        * Scaling and multiple addition.  <tt>*this = s*(*this)+a*V + b*W +
@@ -917,9 +919,11 @@ namespace parallel
 
       /**
        * Assignment <tt>*this = a*u + b*v</tt>.
+       *
+       * This function is deprecated.
        */
       void equ (const Number a, const Vector<Number> &u,
-                const Number b, const Vector<Number> &v);
+                const Number b, const Vector<Number> &v) DEAL_II_DEPRECATED;
 
       /**
        * Assignment <tt>*this = a*u + b*v + b*w</tt>.
index 84e051cea720f0b94d08756c35fdc30fda83d52a..38412c37abbfb033fe1f3567b1364152029db873 100644 (file)
@@ -629,12 +629,14 @@ namespace PETScWrappers
 
     /**
      * Scaling and multiple addition.
+     *
+     * This function is deprecated.
      */
     void sadd (const PetscScalar s,
                const PetscScalar a,
                const VectorBase     &V,
                const PetscScalar b,
-               const VectorBase     &W);
+               const VectorBase     &W) DEAL_II_DEPRECATED;
 
     /**
      * Scaling and multiple addition. <tt>*this = s*(*this)+a*V + b*W +
@@ -664,9 +666,11 @@ namespace PETScWrappers
 
     /**
      * Assignment <tt>*this = a*V + b*W</tt>.
+     *
+     * This function is deprecated.
      */
     void equ (const PetscScalar a, const VectorBase &V,
-              const PetscScalar b, const VectorBase &W);
+              const PetscScalar b, const VectorBase &W) DEAL_II_DEPRECATED;
 
     /**
      * Compute the elementwise ratio of the two given vectors, that is let
index 5c08b27705930259e3489355bdce4f2a2ad2a641..0992dd6c9ab9e6f12c49dc6cd3ecf6490d0fcdda 100644 (file)
@@ -376,7 +376,10 @@ SolverBicgstab<VECTOR>::iterate(const MATRIX &A,
           startup = false;
         }
       else
-        p.sadd(beta, 1., r, -beta*omega, v);
+        {
+          p.sadd(beta, 1., r);
+          p.add(-beta*omega, v);
+        }
 
       precondition.vmult(y,p);
       A.vmult(v,y);
index 6a0aca5595f59d5605b12285512285bd4f069f9e..896e71b499414330a93f85b741443bfafd033adc 100644 (file)
@@ -737,12 +737,14 @@ namespace TrilinosWrappers
 
     /**
      * Scaling and multiple addition.
+     *
+     * This function is deprecated.
      */
     void sadd (const TrilinosScalar  s,
                const TrilinosScalar  a,
                const VectorBase     &V,
                const TrilinosScalar  b,
-               const VectorBase     &W);
+               const VectorBase     &W) DEAL_II_DEPRECATED;
 
     /**
      * Scaling and multiple addition.  <tt>*this = s*(*this) + a*V + b*W +
@@ -773,11 +775,13 @@ namespace TrilinosWrappers
 
     /**
      * Assignment <tt>*this = a*V + b*W</tt>.
+     *
+     * This function is deprecated.
      */
     void equ (const TrilinosScalar  a,
               const VectorBase     &V,
               const TrilinosScalar  b,
-              const VectorBase     &W);
+              const VectorBase     &W) DEAL_II_DEPRECATED;
 
     /**
      * Compute the elementwise ratio of the two given vectors, that is let
@@ -1936,45 +1940,6 @@ namespace TrilinosWrappers
 
 
 
-  inline
-  void
-  VectorBase::equ (const TrilinosScalar  a,
-                   const VectorBase     &v,
-                   const TrilinosScalar  b,
-                   const VectorBase     &w)
-  {
-    // if we have ghost values, do not allow
-    // writing to this vector at all.
-    Assert (!has_ghost_elements(), ExcGhostsPresent());
-    Assert (v.local_size() == w.local_size(),
-            ExcDimensionMismatch (v.local_size(), w.local_size()));
-
-    AssertIsFinite(a);
-    AssertIsFinite(b);
-
-    // If we don't have the same map, copy.
-    if (vector->Map().SameAs(v.vector->Map())==false)
-      {
-        sadd(0., a, v, b, w);
-      }
-    else
-      {
-        // Otherwise, just update. verify
-        // that *this does not only have
-        // the same map as v (the
-        // if-condition above) but also as
-        // w
-        Assert (vector->Map().SameAs(w.vector->Map()),
-                ExcDifferentParallelPartitioning());
-        int ierr = vector->Update(a, *v.vector, b, *w.vector, 0.0);
-        AssertThrow (ierr == 0, ExcTrilinosError(ierr));
-
-        last_action = Zero;
-      }
-  }
-
-
-
   inline
   void
   VectorBase::ratio (const VectorBase &v,
index 4882789621b673e60c41b7b7234b36e9433408c0..f80c0a2e78327e61c67eadc93291254d7d7d992f 100644 (file)
@@ -707,13 +707,15 @@ public:
   /**
    * Scaling and multiple addition.
    *
+   * This function is deprecated.
+   *
    * @dealiiOperationIsMultithreaded
    */
   void sadd (const Number          s,
              const Number          a,
              const Vector<Number> &V,
              const Number          b,
-             const Vector<Number> &W);
+             const Vector<Number> &W) DEAL_II_DEPRECATED;
 
   /**
    * Scaling and multiple addition.  <tt>*this = s*(*this)+a*V + b*W +
@@ -778,10 +780,12 @@ public:
   /**
    * Assignment <tt>*this = a*u + b*v</tt>.
    *
+   * This function is deprecated.
+   *
    * @dealiiOperationIsMultithreaded
    */
   void equ (const Number a, const Vector<Number> &u,
-            const Number b, const Vector<Number> &v);
+            const Number b, const Vector<Number> &v) DEAL_II_DEPRECATED;
 
   /**
    * Assignment <tt>*this = a*u + b*v + b*w</tt>.
index 552b534c498cb9ce1431c8ab6f7824da6b348cd1..d90e9c6b2bf94f0ee1a6e0b7055e5a79ac8779bf 100644 (file)
@@ -414,6 +414,44 @@ namespace TrilinosWrappers
 
 
 
+  void
+  VectorBase::equ (const TrilinosScalar  a,
+                   const VectorBase     &v,
+                   const TrilinosScalar  b,
+                   const VectorBase     &w)
+  {
+    // if we have ghost values, do not allow
+    // writing to this vector at all.
+    Assert (!has_ghost_elements(), ExcGhostsPresent());
+    Assert (v.local_size() == w.local_size(),
+            ExcDimensionMismatch (v.local_size(), w.local_size()));
+
+    AssertIsFinite(a);
+    AssertIsFinite(b);
+
+    // If we don't have the same map, copy.
+    if (vector->Map().SameAs(v.vector->Map())==false)
+      {
+        sadd(0., a, v, b, w);
+      }
+    else
+      {
+        // Otherwise, just update. verify
+        // that *this does not only have
+        // the same map as v (the
+        // if-condition above) but also as
+        // w
+        Assert (vector->Map().SameAs(w.vector->Map()),
+                ExcDifferentParallelPartitioning());
+        int ierr = vector->Update(a, *v.vector, b, *w.vector, 0.0);
+        AssertThrow (ierr == 0, ExcTrilinosError(ierr));
+
+        last_action = Zero;
+      }
+  }
+
+
+
   // TODO: up to now only local
   // data printed out! Find a
   // way to neatly output

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.