From 37da33fc5869ade5ef9519407f774c9521e07966 Mon Sep 17 00:00:00 2001 From: Daniel Arndt Date: Mon, 12 Jun 2017 22:33:06 +0200 Subject: [PATCH] Remove more deprecated member methods in vector classes --- .../incompatibilities/20170612DanielArndt | 4 +- include/deal.II/lac/petsc_vector_base.h | 33 ------ include/deal.II/lac/vector.h | 50 --------- include/deal.II/lac/vector.templates.h | 63 ----------- source/lac/petsc_vector_base.cc | 77 ------------- tests/lac/vector-vector.cc | 6 - tests/lac/vector-vector.output | 24 ++-- tests/vector/complex_vector_43.cc | 94 ---------------- tests/vector/complex_vector_43.output | 2 - tests/vector/complex_vector_44.cc | 103 ------------------ tests/vector/complex_vector_44.output | 2 - tests/vector/complex_vector_47.cc | 95 ---------------- tests/vector/complex_vector_47.output | 2 - tests/vector/vector_43.cc | 93 ---------------- tests/vector/vector_43.output | 2 - tests/vector/vector_44.cc | 98 ----------------- tests/vector/vector_44.output | 2 - tests/vector/vector_47.cc | 93 ---------------- tests/vector/vector_47.output | 2 - 19 files changed, 11 insertions(+), 834 deletions(-) delete mode 100644 tests/vector/complex_vector_43.cc delete mode 100644 tests/vector/complex_vector_43.output delete mode 100644 tests/vector/complex_vector_44.cc delete mode 100644 tests/vector/complex_vector_44.output delete mode 100644 tests/vector/complex_vector_47.cc delete mode 100644 tests/vector/complex_vector_47.output delete mode 100644 tests/vector/vector_43.cc delete mode 100644 tests/vector/vector_43.output delete mode 100644 tests/vector/vector_44.cc delete mode 100644 tests/vector/vector_44.output delete mode 100644 tests/vector/vector_47.cc delete mode 100644 tests/vector/vector_47.output diff --git a/doc/news/changes/incompatibilities/20170612DanielArndt b/doc/news/changes/incompatibilities/20170612DanielArndt index de9dea0042..ac74d1da7c 100644 --- a/doc/news/changes/incompatibilities/20170612DanielArndt +++ b/doc/news/changes/incompatibilities/20170612DanielArndt @@ -1,4 +1,4 @@ -Changed: The deprecated member functions add(), normalize(), conjugate(), abs() -and mult() in the vector classes have been removed. +Changed: The deprecated member functions add(), normalize(), conjugate(), +abs(), sadd(), equ() and mult() in the vector classes have been removed.
(Daniel Arndt, 2017/06/12) diff --git a/include/deal.II/lac/petsc_vector_base.h b/include/deal.II/lac/petsc_vector_base.h index 0306d34ef7..505cfaf313 100644 --- a/include/deal.II/lac/petsc_vector_base.h +++ b/include/deal.II/lac/petsc_vector_base.h @@ -593,31 +593,6 @@ namespace PETScWrappers const PetscScalar a, const VectorBase &V); - /** - * 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) DEAL_II_DEPRECATED; - - /** - * Scaling and multiple addition. *this = s*(*this)+a*V + b*W + - * c*X. - * - * This function is deprecated. - */ - void sadd (const PetscScalar s, - const PetscScalar a, - const VectorBase &V, - const PetscScalar b, - const VectorBase &W, - const PetscScalar c, - const VectorBase &X) DEAL_II_DEPRECATED; - /** * Scale each element of this vector by the corresponding element in the * argument. This function is mostly meant to simulate multiplication (and @@ -630,14 +605,6 @@ namespace PETScWrappers */ void equ (const PetscScalar a, const VectorBase &V); - /** - * Assignment *this = a*V + b*W. - * - * This function is deprecated. - */ - void equ (const PetscScalar a, const VectorBase &V, - const PetscScalar b, const VectorBase &W) DEAL_II_DEPRECATED; - /** * Compute the elementwise ratio of the two given vectors, that is let * this[i] = a[i]/b[i]. This is useful for example if you want to diff --git a/include/deal.II/lac/vector.h b/include/deal.II/lac/vector.h index 527b1999c8..9c42d43339 100644 --- a/include/deal.II/lac/vector.h +++ b/include/deal.II/lac/vector.h @@ -672,35 +672,6 @@ public: const Number a, const Vector &V); - /** - * Scaling and multiple addition. - * - * This function is deprecated. - * - * @dealiiOperationIsMultithreaded - */ - void sadd (const Number s, - const Number a, - const Vector &V, - const Number b, - const Vector &W) DEAL_II_DEPRECATED; - - /** - * Scaling and multiple addition. *this = s*(*this)+a*V + b*W + - * c*X. - * - * This function is deprecated. - * - * @dealiiOperationIsMultithreaded - */ - void sadd (const Number s, - const Number a, - const Vector &V, - const Number b, - const Vector &W, - const Number c, - const Vector &X) DEAL_II_DEPRECATED; - /** * Scale each element of the vector by a constant value. * @@ -745,27 +716,6 @@ public: template void equ (const Number a, const Vector &u); - /** - * Assignment *this = a*u + b*v. - * - * This function is deprecated. - * - * @dealiiOperationIsMultithreaded - */ - void equ (const Number a, const Vector &u, - const Number b, const Vector &v) DEAL_II_DEPRECATED; - - /** - * Assignment *this = a*u + b*v + b*w. - * - * This function is deprecated. - * - * @dealiiOperationIsMultithreaded - */ - void equ (const Number a, const Vector &u, - const Number b, const Vector &v, - const Number c, const Vector &w) DEAL_II_DEPRECATED; - /** * Compute the elementwise ratio of the two given vectors, that is let * this[i] = a[i]/b[i]. This is useful for example if you want to diff --git a/include/deal.II/lac/vector.templates.h b/include/deal.II/lac/vector.templates.h index d4ab64aa72..979b90afb1 100644 --- a/include/deal.II/lac/vector.templates.h +++ b/include/deal.II/lac/vector.templates.h @@ -678,37 +678,6 @@ void Vector::sadd (const Number x, -template -void Vector::sadd (const Number x, const Number a, - const Vector &v, const Number b, - const Vector &w) -{ - AssertIsFinite(x); - AssertIsFinite(a); - AssertIsFinite(b); - - Assert (vec_size!=0, ExcEmptyObject()); - Assert (vec_size == v.vec_size, ExcDimensionMismatch(vec_size, v.vec_size)); - Assert (vec_size == w.vec_size, ExcDimensionMismatch(vec_size, w.vec_size)); - - internal::VectorOperations::Vectorization_sadd_xavbw vector_sadd(val, v.val, w.val, x, - a, b); - internal::VectorOperations::parallel_for(vector_sadd,0,vec_size,thread_loop_partitioner); -} - - -template -void Vector::sadd (const Number x, const Number a, - const Vector &v, const Number b, - const Vector &w, const Number c, - const Vector &y) -{ - sadd (x, a, v, b, w); - add (c, y); -} - - - template void Vector::scale (const Vector &s) { @@ -771,38 +740,6 @@ void Vector::equ (const Number a, -template -void Vector::equ (const Number a, const Vector &u, - const Number b, const Vector &v) -{ - AssertIsFinite(a); - AssertIsFinite(b); - - Assert (vec_size!=0, ExcEmptyObject()); - Assert (vec_size == u.vec_size, ExcDimensionMismatch(vec_size, u.vec_size)); - Assert (vec_size == v.vec_size, ExcDimensionMismatch(vec_size, v.vec_size)); - - internal::VectorOperations::Vectorization_equ_aubv vector_equ(val, u.val, v.val, a, b); - internal::VectorOperations::parallel_for(vector_equ,0,vec_size,thread_loop_partitioner); -} - - -template -void Vector::equ (const Number a, const Vector &u, - const Number b, const Vector &v, - const Number c, const Vector &w) -{ - Assert (vec_size!=0, ExcEmptyObject()); - Assert (vec_size == u.vec_size, ExcDimensionMismatch(vec_size, u.vec_size)); - Assert (vec_size == v.vec_size, ExcDimensionMismatch(vec_size, v.vec_size)); - Assert (vec_size == w.vec_size, ExcDimensionMismatch(vec_size, w.vec_size)); - - internal::VectorOperations::Vectorization_equ_aubvcw vector_equ(val, u.val, v.val, w.val, - a, b, c); - internal::VectorOperations::parallel_for(vector_equ,0,vec_size,thread_loop_partitioner); -} - - template void Vector::ratio (const Vector &a, const Vector &b) diff --git a/source/lac/petsc_vector_base.cc b/source/lac/petsc_vector_base.cc index 4506e2edf9..76042c8686 100644 --- a/source/lac/petsc_vector_base.cc +++ b/source/lac/petsc_vector_base.cc @@ -802,59 +802,6 @@ namespace PETScWrappers - void - VectorBase::sadd (const PetscScalar s, - const PetscScalar a, - const VectorBase &v, - const PetscScalar b, - const VectorBase &w) - { - Assert (!has_ghost_elements(), ExcGhostsPresent()); - AssertIsFinite(s); - AssertIsFinite(a); - AssertIsFinite(b); - - // there is no operation like MAXPAY, so - // do it in two steps - *this *= s; - - const PetscScalar weights[2] = {a,b}; - Vec addends[2] = {v.vector,w.vector}; - - const PetscErrorCode ierr = VecMAXPY (vector, 2, weights, addends); - AssertThrow (ierr == 0, ExcPETScError(ierr)); - } - - - - void - VectorBase::sadd (const PetscScalar s, - const PetscScalar a, - const VectorBase &v, - const PetscScalar b, - const VectorBase &w, - const PetscScalar c, - const VectorBase &x) - { - Assert (!has_ghost_elements(), ExcGhostsPresent()); - AssertIsFinite(s); - AssertIsFinite(a); - AssertIsFinite(b); - AssertIsFinite(c); - - // there is no operation like MAXPAY, so - // do it in two steps - *this *= s; - - const PetscScalar weights[3] = {a,b,c}; - Vec addends[3] = {v.vector, w.vector, x.vector}; - - const PetscErrorCode ierr = VecMAXPY (vector, 3, weights, addends); - AssertThrow (ierr == 0, ExcPETScError(ierr)); - } - - - void VectorBase::scale (const VectorBase &factors) { @@ -887,30 +834,6 @@ namespace PETScWrappers - void - VectorBase::equ (const PetscScalar a, - const VectorBase &v, - const PetscScalar b, - const VectorBase &w) - { - Assert (!has_ghost_elements(), ExcGhostsPresent()); - AssertIsFinite(a); - AssertIsFinite(b); - - Assert (size() == v.size(), - ExcDimensionMismatch (size(), v.size())); - - // there is no simple operation for this - // in PETSc. there are multiple ways to - // emulate it, we choose this one: - const PetscErrorCode ierr = VecCopy (v.vector, vector); - AssertThrow (ierr == 0, ExcPETScError(ierr)); - - sadd (a, b, w); - } - - - void VectorBase::ratio (const VectorBase &a, const VectorBase &b) diff --git a/tests/lac/vector-vector.cc b/tests/lac/vector-vector.cc index 8e286bb2c0..e7f99c9dc9 100644 --- a/tests/lac/vector-vector.cc +++ b/tests/lac/vector-vector.cc @@ -134,9 +134,6 @@ void check_vectors (Vector &d1, Vector &d2) d2.sadd (2., .5, d1); print (d2); - d1.sadd (2, 2, d2, 2, d3); - print (d1); - d1 *= 4.; print (d1); @@ -145,9 +142,6 @@ void check_vectors (Vector &d1, Vector &d2) d2.equ (.25, d1); print (d2); - d2.equ (.25, d1, 2, d3); - print (d2); - d1.ratio (d1, d2); print (d1); } diff --git a/tests/lac/vector-vector.output b/tests/lac/vector-vector.output index 43ff5eb289..0f394f47fe 100644 --- a/tests/lac/vector-vector.output +++ b/tests/lac/vector-vector.output @@ -24,12 +24,10 @@ DEAL::4.00 4.75 5.50 6.25 7.00 7.75 8.50 9.25 10.00 10.75 DEAL::sadd & scale DEAL::-1.00 -0.25 0.50 1.25 2.00 2.75 3.50 4.25 5.00 5.75 DEAL::0 1.88 3.75 5.62 7.50 9.38 11.25 13.12 15.00 16.88 -DEAL::12.00 16.25 20.50 24.75 29.00 33.25 37.50 41.75 46.00 50.25 -DEAL::48.00 65.00 82.00 99.00 116.00 133.00 150.00 167.00 184.00 201.00 +DEAL::16.00 19.00 22.00 25.00 28.00 31.00 34.00 37.00 40.00 43.00 DEAL::equ -DEAL::12.00 16.25 20.50 24.75 29.00 33.25 37.50 41.75 46.00 50.25 -DEAL::16.00 19.25 22.50 25.75 29.00 32.25 35.50 38.75 42.00 45.25 -DEAL::3.00 3.38 3.64 3.84 4.00 4.12 4.23 4.31 4.38 4.44 +DEAL::4.00 4.75 5.50 6.25 7.00 7.75 8.50 9.25 10.00 10.75 +DEAL::4.00 4.00 4.00 4.00 4.00 4.00 4.00 4.00 4.00 4.00 DEAL::Fill & Swap DEAL::0.00 0.00 0.00 0.00 0.00 0.00 0.00 0.00 0.00 0.00 DEAL::0.00 2.00 4.00 6.00 8.00 10.00 12.00 14.00 16.00 18.00 @@ -55,12 +53,10 @@ DEAL::4.00 4.75 5.50 6.25 7.00 7.75 8.50 9.25 10.00 10.75 DEAL::sadd & scale DEAL::-1.00 -0.25 0.50 1.25 2.00 2.75 3.50 4.25 5.00 5.75 DEAL::0.00 1.88 3.75 5.62 7.50 9.38 11.25 13.12 15.00 16.88 -DEAL::12.00 16.25 20.50 24.75 29.00 33.25 37.50 41.75 46.00 50.25 -DEAL::48.00 65.00 82.00 99.00 116.00 133.00 150.00 167.00 184.00 201.00 +DEAL::16.00 19.00 22.00 25.00 28.00 31.00 34.00 37.00 40.00 43.00 DEAL::equ -DEAL::12.00 16.25 20.50 24.75 29.00 33.25 37.50 41.75 46.00 50.25 -DEAL::16.00 19.25 22.50 25.75 29.00 32.25 35.50 38.75 42.00 45.25 -DEAL::3.00 3.38 3.64 3.84 4.00 4.12 4.23 4.31 4.38 4.44 +DEAL::4.00 4.75 5.50 6.25 7.00 7.75 8.50 9.25 10.00 10.75 +DEAL::4.00 4.00 4.00 4.00 4.00 4.00 4.00 4.00 4.00 4.00 DEAL::Fill & Swap DEAL::0.00 0.00 0.00 0.00 0.00 0.00 0.00 0.00 0.00 0.00 DEAL::0.00 2.00 4.00 6.00 8.00 10.00 12.00 14.00 16.00 18.00 @@ -86,9 +82,7 @@ DEAL::4.00 4.75 5.50 6.25 7.00 7.75 8.50 9.25 10.00 10.75 DEAL::sadd & scale DEAL::-1.00 -0.25 0.50 1.25 2.00 2.75 3.50 4.25 5.00 5.75 DEAL::0.00 1.88 3.75 5.62 7.50 9.38 11.25 13.12 15.00 16.88 -DEAL::12.00 16.25 20.50 24.75 29.00 33.25 37.50 41.75 46.00 50.25 -DEAL::48.00 65.00 82.00 99.00 116.00 133.00 150.00 167.00 184.00 201.00 +DEAL::16.00 19.00 22.00 25.00 28.00 31.00 34.00 37.00 40.00 43.00 DEAL::equ -DEAL::12.00 16.25 20.50 24.75 29.00 33.25 37.50 41.75 46.00 50.25 -DEAL::16.00 19.25 22.50 25.75 29.00 32.25 35.50 38.75 42.00 45.25 -DEAL::3.00 3.38 3.64 3.84 4.00 4.12 4.23 4.31 4.38 4.44 +DEAL::4.00 4.75 5.50 6.25 7.00 7.75 8.50 9.25 10.00 10.75 +DEAL::4.00 4.00 4.00 4.00 4.00 4.00 4.00 4.00 4.00 4.00 diff --git a/tests/vector/complex_vector_43.cc b/tests/vector/complex_vector_43.cc deleted file mode 100644 index 3079fd0bac..0000000000 --- a/tests/vector/complex_vector_43.cc +++ /dev/null @@ -1,94 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2004 - 2016 by the deal.II authors -// -// This file is part of the deal.II library. -// -// The deal.II library is free software; you can use it, redistribute -// it, and/or modify it under the terms of the GNU Lesser General -// Public License as published by the Free Software Foundation; either -// version 2.1 of the License, or (at your option) any later version. -// The full text of the license can be found in the file LICENSE at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - - - -// check Vector >::sadd(s,s,V,s,V) - -#include "../tests.h" -#include -#include -#include -#include - - -void test (Vector > &v, - Vector > &w, - Vector > &x) -{ - for (unsigned int i=0; i (i+1., i+2.); - x(i) = i+2.; - } - - v.compress (); - w.compress (); - x.compress (); - - v.sadd (1.5, 2, w, 3, x); - - // make sure we get the expected result - for (unsigned int i=0; i (i+1., i+2.), ExcInternalError()); - AssertThrow (x(i) == i+2., ExcInternalError()); - AssertThrow (v(i) == 1.5*i+2.*std::complex (i+1., i+2.)+3*(i+2.), - ExcInternalError()); - } - - deallog << "OK" << std::endl; -} - - - -int main () -{ - initlog(); - deallog.threshold_double(1.e-10); - - try - { - Vector > v (100); - Vector > w (100); - Vector > x (100); - test (v,w,x); - } - catch (std::exception &exc) - { - deallog << std::endl << std::endl - << "----------------------------------------------------" - << std::endl; - deallog << "Exception on processing: " << std::endl - << exc.what() << std::endl - << "Aborting!" << std::endl - << "----------------------------------------------------" - << std::endl; - - return 1; - } - catch (...) - { - deallog << std::endl << std::endl - << "----------------------------------------------------" - << std::endl; - deallog << "Unknown exception!" << std::endl - << "Aborting!" << std::endl - << "----------------------------------------------------" - << std::endl; - return 1; - }; -} diff --git a/tests/vector/complex_vector_43.output b/tests/vector/complex_vector_43.output deleted file mode 100644 index 0fd8fc12f0..0000000000 --- a/tests/vector/complex_vector_43.output +++ /dev/null @@ -1,2 +0,0 @@ - -DEAL::OK diff --git a/tests/vector/complex_vector_44.cc b/tests/vector/complex_vector_44.cc deleted file mode 100644 index d7837de2b9..0000000000 --- a/tests/vector/complex_vector_44.cc +++ /dev/null @@ -1,103 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2004 - 2016 by the deal.II authors -// -// This file is part of the deal.II library. -// -// The deal.II library is free software; you can use it, redistribute -// it, and/or modify it under the terms of the GNU Lesser General -// Public License as published by the Free Software Foundation; either -// version 2.1 of the License, or (at your option) any later version. -// The full text of the license can be found in the file LICENSE at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - - - -// check Vector >::sadd(s,s,V,s,V,s,V) - -#include "../tests.h" -#include -#include -#include -#include - - -void test (Vector > &v, - Vector > &w, - Vector > &x, - Vector > &y) -{ - for (unsigned int i=0; i (i+1., i+2.); - x(i) = i+2.; - y(i) = std::complex (i+3., i+4.); - } - - v.compress (); - w.compress (); - x.compress (); - y.compress (); - - v.sadd (1.5, 2, w, 3, x, 4, y); - - // make sure we get the expected result - for (unsigned int i=0; i (i+1., i+2.), - ExcInternalError()); - AssertThrow (x(i) == i+2., ExcInternalError()); - AssertThrow (y(i) == std::complex (i+3., i+4.), - ExcInternalError()); - AssertThrow (v(i) == - 1.5*i+2.*std::complex (i+1., i+2.)+ - 3.*(i+2.)+4.*std::complex (i+3., i+4.), - ExcInternalError()); - } - - deallog << "OK" << std::endl; -} - - - -int main () -{ - initlog(); - deallog.threshold_double(1.e-10); - - try - { - Vector > v (100); - Vector > w (100); - Vector > x (100); - Vector > y (100); - test (v,w,x,y); - } - catch (std::exception &exc) - { - deallog << std::endl << std::endl - << "----------------------------------------------------" - << std::endl; - deallog << "Exception on processing: " << std::endl - << exc.what() << std::endl - << "Aborting!" << std::endl - << "----------------------------------------------------" - << std::endl; - - return 1; - } - catch (...) - { - deallog << std::endl << std::endl - << "----------------------------------------------------" - << std::endl; - deallog << "Unknown exception!" << std::endl - << "Aborting!" << std::endl - << "----------------------------------------------------" - << std::endl; - return 1; - }; -} diff --git a/tests/vector/complex_vector_44.output b/tests/vector/complex_vector_44.output deleted file mode 100644 index 0fd8fc12f0..0000000000 --- a/tests/vector/complex_vector_44.output +++ /dev/null @@ -1,2 +0,0 @@ - -DEAL::OK diff --git a/tests/vector/complex_vector_47.cc b/tests/vector/complex_vector_47.cc deleted file mode 100644 index 08fb34407d..0000000000 --- a/tests/vector/complex_vector_47.cc +++ /dev/null @@ -1,95 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2004 - 2016 by the deal.II authors -// -// This file is part of the deal.II library. -// -// The deal.II library is free software; you can use it, redistribute -// it, and/or modify it under the terms of the GNU Lesser General -// Public License as published by the Free Software Foundation; either -// version 2.1 of the License, or (at your option) any later version. -// The full text of the license can be found in the file LICENSE at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - - - -// check Vector >::equ (s,V,s,V) - -#include "../tests.h" -#include -#include -#include -#include - - -void test (Vector > &v, - Vector > &w, - Vector > &x) -{ - for (unsigned int i=0; i (i+1., i+2.); - x(i) = i+2.; - } - - v.compress (); - w.compress (); - x.compress (); - - v.equ (2, w, 3, x); - - // make sure we get the expected result - for (unsigned int i=0; i (i+1., i+2.), - ExcInternalError()); - AssertThrow (x(i) == i+2., ExcInternalError()); - AssertThrow (v(i) == 2.*std::complex (i+1., i+2.)+3.*(i+2.), - ExcInternalError()); - } - - deallog << "OK" << std::endl; -} - - - -int main () -{ - initlog(); - deallog.threshold_double(1.e-10); - - try - { - Vector > v (100); - Vector > w (100); - Vector > x (100); - test (v,w,x); - } - catch (std::exception &exc) - { - deallog << std::endl << std::endl - << "----------------------------------------------------" - << std::endl; - deallog << "Exception on processing: " << std::endl - << exc.what() << std::endl - << "Aborting!" << std::endl - << "----------------------------------------------------" - << std::endl; - - return 1; - } - catch (...) - { - deallog << std::endl << std::endl - << "----------------------------------------------------" - << std::endl; - deallog << "Unknown exception!" << std::endl - << "Aborting!" << std::endl - << "----------------------------------------------------" - << std::endl; - return 1; - }; -} diff --git a/tests/vector/complex_vector_47.output b/tests/vector/complex_vector_47.output deleted file mode 100644 index 0fd8fc12f0..0000000000 --- a/tests/vector/complex_vector_47.output +++ /dev/null @@ -1,2 +0,0 @@ - -DEAL::OK diff --git a/tests/vector/vector_43.cc b/tests/vector/vector_43.cc deleted file mode 100644 index dc9f2d1811..0000000000 --- a/tests/vector/vector_43.cc +++ /dev/null @@ -1,93 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2004 - 2016 by the deal.II authors -// -// This file is part of the deal.II library. -// -// The deal.II library is free software; you can use it, redistribute -// it, and/or modify it under the terms of the GNU Lesser General -// Public License as published by the Free Software Foundation; either -// version 2.1 of the License, or (at your option) any later version. -// The full text of the license can be found in the file LICENSE at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - - - -// check Vector::sadd(s,s,V,s,V) - -#include "../tests.h" -#include -#include -#include -#include - - -void test (Vector &v, - Vector &w, - Vector &x) -{ - for (unsigned int i=0; i v (100); - Vector w (100); - Vector x (100); - test (v,w,x); - } - catch (std::exception &exc) - { - deallog << std::endl << std::endl - << "----------------------------------------------------" - << std::endl; - deallog << "Exception on processing: " << std::endl - << exc.what() << std::endl - << "Aborting!" << std::endl - << "----------------------------------------------------" - << std::endl; - - return 1; - } - catch (...) - { - deallog << std::endl << std::endl - << "----------------------------------------------------" - << std::endl; - deallog << "Unknown exception!" << std::endl - << "Aborting!" << std::endl - << "----------------------------------------------------" - << std::endl; - return 1; - }; -} diff --git a/tests/vector/vector_43.output b/tests/vector/vector_43.output deleted file mode 100644 index 0fd8fc12f0..0000000000 --- a/tests/vector/vector_43.output +++ /dev/null @@ -1,2 +0,0 @@ - -DEAL::OK diff --git a/tests/vector/vector_44.cc b/tests/vector/vector_44.cc deleted file mode 100644 index 33f6fd0990..0000000000 --- a/tests/vector/vector_44.cc +++ /dev/null @@ -1,98 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2004 - 2016 by the deal.II authors -// -// This file is part of the deal.II library. -// -// The deal.II library is free software; you can use it, redistribute -// it, and/or modify it under the terms of the GNU Lesser General -// Public License as published by the Free Software Foundation; either -// version 2.1 of the License, or (at your option) any later version. -// The full text of the license can be found in the file LICENSE at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - - - -// check Vector::sadd(s,s,V,s,V,s,V) - -#include "../tests.h" -#include -#include -#include -#include - - -void test (Vector &v, - Vector &w, - Vector &x, - Vector &y) -{ - for (unsigned int i=0; i v (100); - Vector w (100); - Vector x (100); - Vector y (100); - test (v,w,x,y); - } - catch (std::exception &exc) - { - deallog << std::endl << std::endl - << "----------------------------------------------------" - << std::endl; - deallog << "Exception on processing: " << std::endl - << exc.what() << std::endl - << "Aborting!" << std::endl - << "----------------------------------------------------" - << std::endl; - - return 1; - } - catch (...) - { - deallog << std::endl << std::endl - << "----------------------------------------------------" - << std::endl; - deallog << "Unknown exception!" << std::endl - << "Aborting!" << std::endl - << "----------------------------------------------------" - << std::endl; - return 1; - }; -} diff --git a/tests/vector/vector_44.output b/tests/vector/vector_44.output deleted file mode 100644 index 0fd8fc12f0..0000000000 --- a/tests/vector/vector_44.output +++ /dev/null @@ -1,2 +0,0 @@ - -DEAL::OK diff --git a/tests/vector/vector_47.cc b/tests/vector/vector_47.cc deleted file mode 100644 index 8a71ccf439..0000000000 --- a/tests/vector/vector_47.cc +++ /dev/null @@ -1,93 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2004 - 2016 by the deal.II authors -// -// This file is part of the deal.II library. -// -// The deal.II library is free software; you can use it, redistribute -// it, and/or modify it under the terms of the GNU Lesser General -// Public License as published by the Free Software Foundation; either -// version 2.1 of the License, or (at your option) any later version. -// The full text of the license can be found in the file LICENSE at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - - - -// check Vector::equ (s,V,s,V) - -#include "../tests.h" -#include -#include -#include -#include - - -void test (Vector &v, - Vector &w, - Vector &x) -{ - for (unsigned int i=0; i v (100); - Vector w (100); - Vector x (100); - test (v,w,x); - } - catch (std::exception &exc) - { - deallog << std::endl << std::endl - << "----------------------------------------------------" - << std::endl; - deallog << "Exception on processing: " << std::endl - << exc.what() << std::endl - << "Aborting!" << std::endl - << "----------------------------------------------------" - << std::endl; - - return 1; - } - catch (...) - { - deallog << std::endl << std::endl - << "----------------------------------------------------" - << std::endl; - deallog << "Unknown exception!" << std::endl - << "Aborting!" << std::endl - << "----------------------------------------------------" - << std::endl; - return 1; - }; -} diff --git a/tests/vector/vector_47.output b/tests/vector/vector_47.output deleted file mode 100644 index 0fd8fc12f0..0000000000 --- a/tests/vector/vector_47.output +++ /dev/null @@ -1,2 +0,0 @@ - -DEAL::OK -- 2.39.5