From: Daniel Arndt Date: Fri, 27 Mar 2020 20:55:36 +0000 (-0400) Subject: Remove deprecated LAPACKFullMatrix::apply_lu_factorization X-Git-Tag: v9.2.0-rc1~343^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=refs%2Fpull%2F9753%2Fhead;p=dealii.git Remove deprecated LAPACKFullMatrix::apply_lu_factorization --- diff --git a/doc/news/changes/incompatibilities/20200327DanielArndt-3 b/doc/news/changes/incompatibilities/20200327DanielArndt-3 new file mode 100644 index 0000000000..2c83087968 --- /dev/null +++ b/doc/news/changes/incompatibilities/20200327DanielArndt-3 @@ -0,0 +1,5 @@ +Removed: The deprecated member function +LAPACKFullMatrix::apply_lu_factorization() has been removed. Use +LAPACKFullMatrix::solve() instead. +
+(Daniel Arndt, 2020/03/27) diff --git a/include/deal.II/lac/lapack_full_matrix.h b/include/deal.II/lac/lapack_full_matrix.h index 10c885bb89..f615c00f41 100644 --- a/include/deal.II/lac/lapack_full_matrix.h +++ b/include/deal.II/lac/lapack_full_matrix.h @@ -674,36 +674,6 @@ public: void solve(LAPACKFullMatrix &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 &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 &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 diff --git a/source/lac/lapack_full_matrix.cc b/source/lac/lapack_full_matrix.cc index 0fd7259192..db04cc22f4 100644 --- a/source/lac/lapack_full_matrix.cc +++ b/source/lac/lapack_full_matrix.cc @@ -1845,26 +1845,6 @@ LAPACKFullMatrix::solve(LAPACKFullMatrix &B, -template -void -LAPACKFullMatrix::apply_lu_factorization(Vector &v, - const bool transposed) const -{ - solve(v, transposed); -} - - - -template -void -LAPACKFullMatrix::apply_lu_factorization(LAPACKFullMatrix &B, - const bool transposed) const -{ - solve(B, transposed); -} - - - template number LAPACKFullMatrix::determinant() const @@ -2390,7 +2370,7 @@ PreconditionLU::vmult(Vector & dst, const Vector &src) const { dst = src; - matrix->apply_lu_factorization(dst, false); + matrix->solve(dst, false); } @@ -2400,7 +2380,7 @@ PreconditionLU::Tvmult(Vector & dst, const Vector &src) const { dst = src; - matrix->apply_lu_factorization(dst, true); + matrix->solve(dst, true); } @@ -2412,7 +2392,7 @@ PreconditionLU::vmult(BlockVector & dst, Assert(mem != nullptr, ExcNotInitialized()); Vector *aux = mem->alloc(); *aux = src; - matrix->apply_lu_factorization(*aux, false); + matrix->solve(*aux, false); dst = *aux; } @@ -2425,7 +2405,7 @@ PreconditionLU::Tvmult(BlockVector & dst, Assert(mem != nullptr, ExcNotInitialized()); Vector *aux = mem->alloc(); *aux = src; - matrix->apply_lu_factorization(*aux, true); + matrix->solve(*aux, true); dst = *aux; } diff --git a/tests/lapack/full_matrix_02.cc b/tests/lapack/full_matrix_02.cc index 73d052b076..da5fdec758 100644 --- a/tests/lapack/full_matrix_02.cc +++ b/tests/lapack/full_matrix_02.cc @@ -15,7 +15,7 @@ // LAPACKFullMatrix::compute_lu_factorization -// LAPACKFullMatrix::apply_lu_factorization +// LAPACKFullMatrix::solve #include #include @@ -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; diff --git a/tests/lapack/full_matrix_12.cc b/tests/lapack/full_matrix_12.cc index 9472d8388d..dabf769ed2 100644 --- a/tests/lapack/full_matrix_12.cc +++ b/tests/lapack/full_matrix_12.cc @@ -14,7 +14,7 @@ // --------------------------------------------------------------------- -// Tests LAPACKFullMatrix::apply_lu_factorization in two different variants +// Tests LAPACKFullMatrix::solve in two different variants #include #include @@ -42,13 +42,13 @@ test() for (unsigned int transpose = 0; transpose < 2; ++transpose) { LAPACKFullMatrix rhs(rhs_orig); - A.apply_lu_factorization(rhs, transpose); + A.solve(rhs, transpose); for (unsigned int i = 0; i < 3; ++i) { Vector 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()); } diff --git a/tests/lapack/full_matrix_14.cc b/tests/lapack/full_matrix_14.cc index 2c408bc396..afaac64fec 100644 --- a/tests/lapack/full_matrix_14.cc +++ b/tests/lapack/full_matrix_14.cc @@ -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;