]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove deprecated LAPACKFullMatrix::apply_lu_factorization 9753/head
authorDaniel Arndt <arndtd@ornl.gov>
Fri, 27 Mar 2020 20:55:36 +0000 (16:55 -0400)
committerDaniel Arndt <arndtd@ornl.gov>
Fri, 27 Mar 2020 21:56:20 +0000 (17:56 -0400)
doc/news/changes/incompatibilities/20200327DanielArndt-3 [new file with mode: 0644]
include/deal.II/lac/lapack_full_matrix.h
source/lac/lapack_full_matrix.cc
tests/lapack/full_matrix_02.cc
tests/lapack/full_matrix_12.cc
tests/lapack/full_matrix_14.cc

diff --git a/doc/news/changes/incompatibilities/20200327DanielArndt-3 b/doc/news/changes/incompatibilities/20200327DanielArndt-3
new file mode 100644 (file)
index 0000000..2c83087
--- /dev/null
@@ -0,0 +1,5 @@
+Removed: The deprecated member function
+LAPACKFullMatrix::apply_lu_factorization() has been removed. Use
+LAPACKFullMatrix::solve() instead.
+<br>
+(Daniel Arndt, 2020/03/27)
index 10c885bb89e72179b262695f0d827a1295bd9adb..f615c00f4128cb6f865bee0d8efdd4e1a6752413 100644 (file)
@@ -674,36 +674,6 @@ public:
   void
   solve(LAPACKFullMatrix<number> &B, const bool transposed = false) const;
 
-  /**
-   * Solve the linear system with right hand side given by applying
-   * forward/backward substitution to the previously computed LU
-   * factorization. Uses LAPACK function Xgetrs.
-   *
-   * The flag transposed indicates whether the solution of the transposed
-   * system is to be performed.
-   *
-   * @deprecated use solve() instead.
-   */
-  DEAL_II_DEPRECATED
-  void
-  apply_lu_factorization(Vector<number> &v, const bool transposed) const;
-
-  /**
-   * Solve the linear system with multiple right hand sides (as many as there
-   * are columns in the matrix b) given by applying forward/backward
-   * substitution to the previously computed LU factorization. Uses LAPACK
-   * function Xgetrs.
-   *
-   * The flag transposed indicates whether the solution of the transposed
-   * system is to be performed.
-   *
-   * @deprecated use solve() instead.
-   */
-  DEAL_II_DEPRECATED
-  void
-  apply_lu_factorization(LAPACKFullMatrix<number> &B,
-                         const bool                transposed) const;
-
   /**
    * Compute eigenvalues of the matrix. After this routine has been called,
    * eigenvalues can be retrieved using the eigenvalue() function. The matrix
index 0fd7259192178634701822cdcd6458d43a53516b..db04cc22f4b8fccf4ebe0cec734bbcd7c2ee2e55 100644 (file)
@@ -1845,26 +1845,6 @@ LAPACKFullMatrix<number>::solve(LAPACKFullMatrix<number> &B,
 
 
 
-template <typename number>
-void
-LAPACKFullMatrix<number>::apply_lu_factorization(Vector<number> &v,
-                                                 const bool transposed) const
-{
-  solve(v, transposed);
-}
-
-
-
-template <typename number>
-void
-LAPACKFullMatrix<number>::apply_lu_factorization(LAPACKFullMatrix<number> &B,
-                                                 const bool transposed) const
-{
-  solve(B, transposed);
-}
-
-
-
 template <typename number>
 number
 LAPACKFullMatrix<number>::determinant() const
@@ -2390,7 +2370,7 @@ PreconditionLU<number>::vmult(Vector<number> &      dst,
                               const Vector<number> &src) const
 {
   dst = src;
-  matrix->apply_lu_factorization(dst, false);
+  matrix->solve(dst, false);
 }
 
 
@@ -2400,7 +2380,7 @@ PreconditionLU<number>::Tvmult(Vector<number> &      dst,
                                const Vector<number> &src) const
 {
   dst = src;
-  matrix->apply_lu_factorization(dst, true);
+  matrix->solve(dst, true);
 }
 
 
@@ -2412,7 +2392,7 @@ PreconditionLU<number>::vmult(BlockVector<number> &      dst,
   Assert(mem != nullptr, ExcNotInitialized());
   Vector<number> *aux = mem->alloc();
   *aux                = src;
-  matrix->apply_lu_factorization(*aux, false);
+  matrix->solve(*aux, false);
   dst = *aux;
 }
 
@@ -2425,7 +2405,7 @@ PreconditionLU<number>::Tvmult(BlockVector<number> &      dst,
   Assert(mem != nullptr, ExcNotInitialized());
   Vector<number> *aux = mem->alloc();
   *aux                = src;
-  matrix->apply_lu_factorization(*aux, true);
+  matrix->solve(*aux, true);
   dst = *aux;
 }
 
index 73d052b076c74f21ed4c242f41a7547e089ce9e7..da5fdec7580f35d60f5bf8a824f9663d702bb222 100644 (file)
@@ -15,7 +15,7 @@
 
 
 // LAPACKFullMatrix::compute_lu_factorization
-// LAPACKFullMatrix::apply_lu_factorization
+// LAPACKFullMatrix::solve
 
 #include <deal.II/lac/lapack_full_matrix.h>
 #include <deal.II/lac/vector.h>
@@ -60,8 +60,8 @@ test(const unsigned int size, const bool nonsymmetric)
   M.vmult(v, u);
   M.Tvmult(y, x);
   M.compute_lu_factorization();
-  M.apply_lu_factorization(v, false);
-  M.apply_lu_factorization(y, true);
+  M.solve(v, false);
+  M.solve(y, true);
 
   v -= u;
   y -= x;
index 9472d8388d1d79c34a49d0730a4e26cd3318b122..dabf769ed2037306c8ab631755ff16e422cb5a73 100644 (file)
@@ -14,7 +14,7 @@
 // ---------------------------------------------------------------------
 
 
-// Tests LAPACKFullMatrix::apply_lu_factorization in two different variants
+// Tests LAPACKFullMatrix::solve in two different variants
 
 #include <deal.II/lac/lapack_full_matrix.h>
 #include <deal.II/lac/vector.h>
@@ -42,13 +42,13 @@ test()
   for (unsigned int transpose = 0; transpose < 2; ++transpose)
     {
       LAPACKFullMatrix<double> rhs(rhs_orig);
-      A.apply_lu_factorization(rhs, transpose);
+      A.solve(rhs, transpose);
       for (unsigned int i = 0; i < 3; ++i)
         {
           Vector<double> check(n);
           for (unsigned int j = 0; j < n; ++j)
             check(j) = rhs_orig(j, i);
-          A.apply_lu_factorization(check, transpose);
+          A.solve(check, transpose);
           for (unsigned int j = 0; j < n; ++j)
             Assert(std::abs(check(j) - rhs(j, i)) < 1e-13, ExcInternalError());
         }
index 2c408bc3969e6ec12b6d339d429f2c10f22474ca..afaac64fec8df30b38540bd4a1da32714a129cbf 100644 (file)
@@ -55,7 +55,7 @@ test(const bool is_singular)
   v        = 1.0;
   v(n - 1) = 0.0;
   // LU factorization can only be applied if state == lu!
-  A.apply_lu_factorization(v, false);
+  A.solve(v, false);
 
   deallog << "apply lu factorization succeeded with norm " << v.l2_norm()
           << std::endl;

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.