From: ESeNonFossiIo Date: Tue, 16 Jun 2015 19:44:38 +0000 (+0200) Subject: removing tests that require upper and lower triangular block operators X-Git-Tag: v8.3.0-rc1~92^2~4 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=f16d605d973b45c444d243caae3fc135b3a5bb54;p=dealii.git removing tests that require upper and lower triangular block operators --- diff --git a/tests/lac/block_linear_operator_03.cc b/tests/lac/block_linear_operator_03.cc deleted file mode 100644 index dad87eb770..0000000000 --- a/tests/lac/block_linear_operator_03.cc +++ /dev/null @@ -1,101 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2015 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. -// -// --------------------------------------------------------------------- - -// Test lower_triangular_operator: - -#include "../tests.h" - -#include -#include -#include -#include -#include -#include - -#define PRINTME(title, name, var) \ - deallog << title << std::endl; \ - deallog << "Block vector: " name << ":" << std::endl; \ - for (unsigned int i = 0; i < var.n_blocks(); ++i) \ - deallog << "[block " << i << " ] " << var.block(i); - - -using namespace dealii; - -int main() -{ - initlog(); - deallog << std::setprecision(2); - - // BlockSparseMatrix: - { - BlockDynamicSparsityPattern dsp(3, 3); - for (unsigned int i = 0; i < 3; ++i) - for (unsigned int j = 0; j < 3; ++j) - dsp.block(i, j).reinit (1, 1); - dsp.collect_sizes (); - - BlockSparsityPattern sparsity_pattern; - sparsity_pattern.copy_from(dsp); - sparsity_pattern.compress(); - - // | 2 1 0 | | 0 0 0 | - // | 3 2 1 | -> | 3 0 0 | - // | 4 3 2 | | 4 3 0 | - BlockSparseMatrix a (sparsity_pattern); - for (unsigned int i = 0; i < 3; ++i) - for (unsigned int j = 0; j < 3; ++j) - a.block(i,j).set(0, 0, 2 + i - j); - - auto op_a = linear_operator>(a); - auto triangular_block_op = lower_triangular_operator<3, BlockVector, BlockVector, BlockSparseMatrix >(a); - - BlockVector u; - op_a.reinit_domain_vector(u, false); - BlockVector v; - op_a.reinit_range_vector(v, false); - - - // vmult: - for(unsigned int i = 0; i<3; ++i) - { - u.block(i)[0] = i+1; - v.block(i)[0] = 1; - } - - triangular_block_op.vmult(v, u); - PRINTME(" -- vmult --", "v", v); - - // vmult_add: - for(unsigned int i = 0; i<3; ++i) - v.block(i)[0] = 1; - - triangular_block_op.vmult_add(v, u); - PRINTME(" -- vmult_add --", "v", v); - - // Tvmult - for(unsigned int i = 0; i<3; ++i) - v.block(i)[0] = i+1; - - triangular_block_op.Tvmult(u, v); - PRINTME(" -- Tvmult --", "u", u); - - // Tvmult_add - for(unsigned int i = 0; i<3; ++i) - u.block(i)[0] = 1; - - triangular_block_op.Tvmult_add(u, v); - PRINTME(" -- Tvmult_add --", "u", u); - } -} diff --git a/tests/lac/block_linear_operator_03.with_cxx11=on.output b/tests/lac/block_linear_operator_03.with_cxx11=on.output deleted file mode 100644 index 1507567775..0000000000 --- a/tests/lac/block_linear_operator_03.with_cxx11=on.output +++ /dev/null @@ -1,21 +0,0 @@ - -DEAL:: -- vmult -- -DEAL::Block vector: v: -DEAL::[block 0 ] 0.0 -DEAL::[block 1 ] 3.0 -DEAL::[block 2 ] 10. -DEAL:: -- vmult_add -- -DEAL::Block vector: v: -DEAL::[block 0 ] 1.0 -DEAL::[block 1 ] 4.0 -DEAL::[block 2 ] 11. -DEAL:: -- Tvmult -- -DEAL::Block vector: u: -DEAL::[block 0 ] 18. -DEAL::[block 1 ] 9.0 -DEAL::[block 2 ] 0.0 -DEAL:: -- Tvmult_add -- -DEAL::Block vector: u: -DEAL::[block 0 ] 19. -DEAL::[block 1 ] 10. -DEAL::[block 2 ] 1.0 diff --git a/tests/lac/block_linear_operator_04.cc b/tests/lac/block_linear_operator_04.cc deleted file mode 100644 index 7b205309f5..0000000000 --- a/tests/lac/block_linear_operator_04.cc +++ /dev/null @@ -1,101 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2015 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. -// -// --------------------------------------------------------------------- - -// Test upper_triangular_operator: - -#include "../tests.h" - -#include -#include -#include -#include -#include -#include - -#define PRINTME(title, name, var) \ - deallog << title << std::endl; \ - deallog << "Block vector: " name << ":" << std::endl; \ - for (unsigned int i = 0; i < var.n_blocks(); ++i) \ - deallog << "[block " << i << " ] " << var.block(i); - -using namespace dealii; - -int main() -{ - initlog(); - deallog << std::setprecision(2); - - // BlockSparseMatrix: - { - BlockDynamicSparsityPattern dsp(3, 3); - for (unsigned int i = 0; i < 3; ++i) - for (unsigned int j = 0; j < 3; ++j) - dsp.block(i, j).reinit (1, 1); - dsp.collect_sizes (); - - BlockSparsityPattern sparsity_pattern; - sparsity_pattern.copy_from(dsp); - sparsity_pattern.compress(); - - // | 2 3 4 | - // | 1 2 3 | - // | 0 1 2 | - BlockSparseMatrix a (sparsity_pattern); - for (unsigned int i = 0; i < 3; ++i) - for (unsigned int j = 0; j < 3; ++j) - a.block(i,j).set(0, 0, 2 + j - i); - - auto op_a = linear_operator>(a); - - auto triangular_block_op = upper_triangular_operator<3, BlockVector, BlockVector, BlockSparseMatrix >(a); - - BlockVector u; - op_a.reinit_domain_vector(u, false); - BlockVector v; - op_a.reinit_range_vector(v, false); - - - // vmult: - for(unsigned int i = 0; i<3; ++i) - { - u.block(i)[0] = i+1; - v.block(i)[0] = 1; - } - - triangular_block_op.vmult(v, u); - PRINTME(" -- vmult --","v", v); - - // vmult_add: - for(unsigned int i = 0; i<3; ++i) - v.block(i)[0] = 1; - - triangular_block_op.vmult_add(v, u); - PRINTME(" -- vmult_add --", "v", v); - - // Tvmult - for(unsigned int i = 0; i<3; ++i) - v.block(i)[0] = i+1; - - triangular_block_op.Tvmult(u, v); - PRINTME(" -- Tvmult --", "u", u); - - // Tvmult_add - for(unsigned int i = 0; i<3; ++i) - u.block(i)[0] = 1; - - triangular_block_op.Tvmult_add(u, v); - PRINTME(" -- Tvmult_add --", "u", u); - } -} diff --git a/tests/lac/block_linear_operator_04.with_cxx11=on.output b/tests/lac/block_linear_operator_04.with_cxx11=on.output deleted file mode 100644 index 822b43771b..0000000000 --- a/tests/lac/block_linear_operator_04.with_cxx11=on.output +++ /dev/null @@ -1,21 +0,0 @@ - -DEAL:: -- vmult -- -DEAL::Block vector: v: -DEAL::[block 0 ] 18. -DEAL::[block 1 ] 9.0 -DEAL::[block 2 ] 0.0 -DEAL:: -- vmult_add -- -DEAL::Block vector: v: -DEAL::[block 0 ] 19. -DEAL::[block 1 ] 10. -DEAL::[block 2 ] 1.0 -DEAL:: -- Tvmult -- -DEAL::Block vector: u: -DEAL::[block 0 ] 0.0 -DEAL::[block 1 ] 3.0 -DEAL::[block 2 ] 10. -DEAL:: -- Tvmult_add -- -DEAL::Block vector: u: -DEAL::[block 0 ] 1.0 -DEAL::[block 1 ] 4.0 -DEAL::[block 2 ] 11. diff --git a/tests/lac/block_linear_operator_05.cc b/tests/lac/block_linear_operator_05.cc deleted file mode 100644 index b4373fb389..0000000000 --- a/tests/lac/block_linear_operator_05.cc +++ /dev/null @@ -1,136 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2015 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. -// -// --------------------------------------------------------------------- - -// Test upper_triangular_block_op and lower_triangular_operator -// simultaneously: - -#include "../tests.h" - -#include -#include -#include -#include -#include -#include - -#define PRINTME(name, var) \ - deallog << "Block vector: " name << ":" << std::endl; \ - for (unsigned int i = 0; i < var.n_blocks(); ++i) \ - deallog << "[block " << i << " ] " << var.block(i); - - -using namespace dealii; - -int main() -{ - initlog(); - deallog << std::setprecision(2); - - // BlockSparseMatrix: - { - BlockDynamicSparsityPattern dsp(3, 3); - for (unsigned int i = 0; i < 3; ++i) - for (unsigned int j = 0; j < 3; ++j) - dsp.block(i, j).reinit (1, 1); - dsp.collect_sizes (); - - BlockSparsityPattern sparsity_pattern; - sparsity_pattern.copy_from(dsp); - sparsity_pattern.compress(); - - BlockSparseMatrix a (sparsity_pattern); - for (unsigned int i = 0; i < 3; ++i) - for (unsigned int j = 0; j < 3; ++j) - a.block(i,j).set(0, 0, 2 + j + i); - - auto op_a = linear_operator>(a); - - auto lower_triangular_block_op = lower_triangular_operator<3, BlockVector, BlockVector, BlockSparseMatrix >(a); - auto upper_triangular_block_op = upper_triangular_operator<3, BlockVector, BlockVector, BlockSparseMatrix >(a); - - - BlockVector u1; - op_a.reinit_domain_vector(u1, false); - BlockVector v1; - op_a.reinit_range_vector(v1, false); - BlockVector u2; - op_a.reinit_domain_vector(u2, false); - BlockVector v2; - op_a.reinit_range_vector(v2, false); - - - // check 1 - for(unsigned int i = 0; i<3; ++i) - { - u1.block(i)[0] = i+1; - u2.block(i)[0] = i+1; - v1.block(i)[0] = 1; - v2.block(i)[0] = 1; - } - - lower_triangular_block_op.vmult(v1, u1); - upper_triangular_block_op.Tvmult(v2, u2); - - PRINTME("v1", v1); - PRINTME("v2", v2); - - - // check 2 - for(unsigned int i = 0; i<3; ++i) - { - u1.block(i)[0] = i+1; - u2.block(i)[0] = i+1; - v1.block(i)[0] = 1; - v2.block(i)[0] = 1; - } - - lower_triangular_block_op.Tvmult(v1, u1); - upper_triangular_block_op.vmult(v2, u2); - - PRINTME("v1", v1); - PRINTME("v2", v2); - - // check 3 - for(unsigned int i = 0; i<3; ++i) - { - u1.block(i)[0] = i+1; - u2.block(i)[0] = i+1; - v1.block(i)[0] = 1; - v2.block(i)[0] = 1; - } - - lower_triangular_block_op.vmult_add(v1, u1); - upper_triangular_block_op.Tvmult_add(v2, u2); - - PRINTME("v1", v1); - PRINTME("v2", v2); - - - // check 4 - for(unsigned int i = 0; i<3; ++i) - { - u1.block(i)[0] = i+1; - u2.block(i)[0] = i+1; - v1.block(i)[0] = 1; - v2.block(i)[0] = 1; - } - - lower_triangular_block_op.Tvmult_add(v1, u1); - upper_triangular_block_op.vmult_add(v2, u2); - - PRINTME("v1", v1); - PRINTME("v2", v2); - } -} diff --git a/tests/lac/block_linear_operator_05.with_cxx11=on.output b/tests/lac/block_linear_operator_05.with_cxx11=on.output deleted file mode 100644 index 476923c248..0000000000 --- a/tests/lac/block_linear_operator_05.with_cxx11=on.output +++ /dev/null @@ -1,33 +0,0 @@ - -DEAL::Block vector: v1: -DEAL::[block 0 ] 0.0 -DEAL::[block 1 ] 3.0 -DEAL::[block 2 ] 14. -DEAL::Block vector: v2: -DEAL::[block 0 ] 0.0 -DEAL::[block 1 ] 3.0 -DEAL::[block 2 ] 14. -DEAL::Block vector: v1: -DEAL::[block 0 ] 18. -DEAL::[block 1 ] 15. -DEAL::[block 2 ] 0.0 -DEAL::Block vector: v2: -DEAL::[block 0 ] 18. -DEAL::[block 1 ] 15. -DEAL::[block 2 ] 0.0 -DEAL::Block vector: v1: -DEAL::[block 0 ] 1.0 -DEAL::[block 1 ] 4.0 -DEAL::[block 2 ] 15. -DEAL::Block vector: v2: -DEAL::[block 0 ] 1.0 -DEAL::[block 1 ] 4.0 -DEAL::[block 2 ] 15. -DEAL::Block vector: v1: -DEAL::[block 0 ] 19. -DEAL::[block 1 ] 16. -DEAL::[block 2 ] 1.0 -DEAL::Block vector: v2: -DEAL::[block 0 ] 19. -DEAL::[block 1 ] 16. -DEAL::[block 2 ] 1.0 diff --git a/tests/lac/block_linear_operator_07.cc b/tests/lac/block_linear_operator_07.cc deleted file mode 100644 index 91c7ead21f..0000000000 --- a/tests/lac/block_linear_operator_07.cc +++ /dev/null @@ -1,134 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2015 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. -// -// --------------------------------------------------------------------- - -// Test upper_triangular_block_op and lower_triangular_operator -// simultaneously: - -#include "../tests.h" - -#include -#include -#include -#include -#include -#include - -#define PRINTME(name, var) \ - deallog << "Block vector: " name << ":" << std::endl; \ - for (unsigned int j = 0; j < 2; ++j) \ - deallog << "[block " << j << " ] " << var.block(j); - -void reinit_vec(BlockVector &u1, BlockVector &u2, BlockVector &v1, BlockVector &v2) -{ - for(unsigned int i = 0; i<2; ++i) - { - for(unsigned int j = 0; j<2; ++j) - { - u1.block(i)[j] = i+j; - u2.block(i)[j] = i+j; - v1.block(i)[j] = 1; - v2.block(i)[j] = 1; - } - } -} - -using namespace dealii; - -int main() -{ - initlog(); - deallog << std::setprecision(2); - - // BlockSparseMatrix: - { - BlockSparsityPattern dsp(2,2); - // set sizes - for (unsigned int i=0; i<2; ++i) - for (unsigned int j=0; j<2; ++j) - dsp.block(i,j).reinit ( 2, 2, 5); - dsp.collect_sizes (); - - for (unsigned int row=0; row<4; ++row) - for (unsigned int i=0; i<4; ++i) - dsp.add (row, i); - dsp.compress (); - - BlockSparseMatrix a (dsp); - - for (unsigned int i = 0; i < 2; ++i) - for (unsigned int j = 0; j < 2; ++j) - for (unsigned int h = 0; h < 2; ++h) - for (unsigned int k = 0; k < 2; ++k) - a.block(i,j).set(h, k, j + i + h + k); - - auto op_a = linear_operator>(a); - - auto lower_triangular_block_op = lower_triangular_operator<2, BlockVector, BlockVector, BlockSparseMatrix>(a); - auto upper_triangular_block_op = upper_triangular_operator<2, BlockVector, BlockVector, BlockSparseMatrix >(a); - - - BlockVector u1; - op_a.reinit_domain_vector(u1, false); - BlockVector v1; - op_a.reinit_range_vector(v1, false); - BlockVector u2; - op_a.reinit_domain_vector(u2, false); - BlockVector v2; - op_a.reinit_range_vector(v2, false); - - - // check 1 - reinit_vec(u1,u2,v1,v2); - PRINTME("u1", u1); - PRINTME("u2", u2); - PRINTME("v1", v1); - PRINTME("v2", v2); - - lower_triangular_block_op.vmult(v1, u1); - upper_triangular_block_op.Tvmult(v2, u2); - - PRINTME("v1", v1); - PRINTME("v2", v2); - - - // check 2 - reinit_vec(u1,u2,v1,v2); - - lower_triangular_block_op.Tvmult(v1, u1); - upper_triangular_block_op.vmult(v2, u2); - - PRINTME("v1", v1); - PRINTME("v2", v2); - - // check 3 - reinit_vec(u1,u2,v1,v2); - - lower_triangular_block_op.vmult_add(v1, u1); - upper_triangular_block_op.Tvmult_add(v2, u2); - - PRINTME("v1", v1); - PRINTME("v2", v2); - - - // check 4 - reinit_vec(u1,u2,v1,v2); - - lower_triangular_block_op.Tvmult_add(v1, u1); - upper_triangular_block_op.vmult_add(v2, u2); - - PRINTME("v1", v1); - PRINTME("v2", v2); - } -} diff --git a/tests/lac/block_linear_operator_07.with_cxx11=on.output b/tests/lac/block_linear_operator_07.with_cxx11=on.output deleted file mode 100644 index 9d3ee42e60..0000000000 --- a/tests/lac/block_linear_operator_07.with_cxx11=on.output +++ /dev/null @@ -1,37 +0,0 @@ - -DEAL::Block vector: u1: -DEAL::[block 0 ] 0.0 1.0 -DEAL::[block 1 ] 1.0 2.0 -DEAL::Block vector: u2: -DEAL::[block 0 ] 0.0 1.0 -DEAL::[block 1 ] 1.0 2.0 -DEAL::Block vector: v1: -DEAL::[block 0 ] 1.0 1.0 -DEAL::[block 1 ] 1.0 1.0 -DEAL::Block vector: v2: -DEAL::[block 0 ] 1.0 1.0 -DEAL::[block 1 ] 1.0 1.0 -DEAL::Block vector: v1: -DEAL::[block 0 ] 0.0 0.0 -DEAL::[block 1 ] 2.0 3.0 -DEAL::Block vector: v2: -DEAL::[block 0 ] 0.0 0.0 -DEAL::[block 1 ] 2.0 3.0 -DEAL::Block vector: v1: -DEAL::[block 0 ] 5.0 8.0 -DEAL::[block 1 ] 0.0 0.0 -DEAL::Block vector: v2: -DEAL::[block 0 ] 5.0 8.0 -DEAL::[block 1 ] 0.0 0.0 -DEAL::Block vector: v1: -DEAL::[block 0 ] 1.0 1.0 -DEAL::[block 1 ] 3.0 4.0 -DEAL::Block vector: v2: -DEAL::[block 0 ] 1.0 1.0 -DEAL::[block 1 ] 3.0 4.0 -DEAL::Block vector: v1: -DEAL::[block 0 ] 6.0 9.0 -DEAL::[block 1 ] 1.0 1.0 -DEAL::Block vector: v2: -DEAL::[block 0 ] 6.0 9.0 -DEAL::[block 1 ] 1.0 1.0 diff --git a/tests/lac/block_linear_operator_08.cc b/tests/lac/block_linear_operator_08.cc deleted file mode 100644 index cd37399088..0000000000 --- a/tests/lac/block_linear_operator_08.cc +++ /dev/null @@ -1,151 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2015 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. -// -// --------------------------------------------------------------------- - -// Test upper_triangular_block_op and lower_triangular_operator -// (in the case of array of array of LinearOperator as argument) -// simultaneously: - -#include "../tests.h" - -#include -#include -#include -#include -#include -#include - -#define PRINTME(name, var) \ - deallog << "Block vector: " name << ":" << std::endl; \ - for (unsigned int j = 0; j < 2; ++j) \ - deallog << "[block " << j << " ] " << var.block(j); - -void reinit_vec(BlockVector &u1, BlockVector &u2, BlockVector &v1, BlockVector &v2) -{ - for(unsigned int i = 0; i<2; ++i) - { - for(unsigned int j = 0; j<2; ++j) - { - u1.block(i)[j] = i+j; - u2.block(i)[j] = i+j; - v1.block(i)[j] = 1; - v2.block(i)[j] = 1; - } - } -} - -using namespace dealii; - -int main() -{ - initlog(); - deallog << std::setprecision(2); - - // BlockSparseMatrix: - { - BlockSparsityPattern dsp(2,2); - // set sizes - for (unsigned int i=0; i<2; ++i) - for (unsigned int j=0; j<2; ++j) - dsp.block(i,j).reinit ( 2, 2, 5); - dsp.collect_sizes (); - - for (unsigned int row=0; row<4; ++row) - for (unsigned int i=0; i<4; ++i) - dsp.add (row, i); - dsp.compress (); - - BlockSparseMatrix a (dsp); - - for (unsigned int i = 0; i < 2; ++i) - for (unsigned int j = 0; j < 2; ++j) - for (unsigned int h = 0; h < 2; ++h) - for (unsigned int k = 0; k < 2; ++k) - a.block(i,j).set(h, k, j + i + h + k); - - auto op00 = linear_operator,Vector>(a.block(0,0)); - auto op01 = linear_operator,Vector>(a.block(0,1)); - auto op10 = linear_operator,Vector>(a.block(1,0)); - auto op11 = linear_operator,Vector>(a.block(1,1)); - - auto lower_triangular_block_op = - lower_triangular_operator< 2, - BlockVector, - BlockVector>({{ - {{ op00, op01 }} , - {{ op10, op11 }} - } - }); - auto upper_triangular_block_op = - upper_triangular_operator< 2, - BlockVector, - BlockVector>({{ - {{ op00, op01 }} , - {{ op10, op11 }} - } - }); - - BlockVector u1; - lower_triangular_block_op.reinit_domain_vector(u1, false); - BlockVector v1; - lower_triangular_block_op.reinit_range_vector(v1, false); - BlockVector u2; - upper_triangular_block_op.reinit_domain_vector(u2, false); - BlockVector v2; - upper_triangular_block_op.reinit_range_vector(v2, false); - - - // check 1 - reinit_vec(u1,u2,v1,v2); - PRINTME("u1", u1); - PRINTME("u2", u2); - PRINTME("v1", v1); - PRINTME("v2", v2); - - lower_triangular_block_op.vmult(v1, u1); - upper_triangular_block_op.Tvmult(v2, u2); - - PRINTME("v1", v1); - PRINTME("v2", v2); - - - // check 2 - reinit_vec(u1,u2,v1,v2); - - lower_triangular_block_op.Tvmult(v1, u1); - upper_triangular_block_op.vmult(v2, u2); - - PRINTME("v1", v1); - PRINTME("v2", v2); - - // check 3 - reinit_vec(u1,u2,v1,v2); - - lower_triangular_block_op.vmult_add(v1, u1); - upper_triangular_block_op.Tvmult_add(v2, u2); - - PRINTME("v1", v1); - PRINTME("v2", v2); - - - // check 4 - reinit_vec(u1,u2,v1,v2); - - lower_triangular_block_op.Tvmult_add(v1, u1); - upper_triangular_block_op.vmult_add(v2, u2); - - PRINTME("v1", v1); - PRINTME("v2", v2); - } -} diff --git a/tests/lac/block_linear_operator_08.with_cxx11=on.output b/tests/lac/block_linear_operator_08.with_cxx11=on.output deleted file mode 100644 index 9d3ee42e60..0000000000 --- a/tests/lac/block_linear_operator_08.with_cxx11=on.output +++ /dev/null @@ -1,37 +0,0 @@ - -DEAL::Block vector: u1: -DEAL::[block 0 ] 0.0 1.0 -DEAL::[block 1 ] 1.0 2.0 -DEAL::Block vector: u2: -DEAL::[block 0 ] 0.0 1.0 -DEAL::[block 1 ] 1.0 2.0 -DEAL::Block vector: v1: -DEAL::[block 0 ] 1.0 1.0 -DEAL::[block 1 ] 1.0 1.0 -DEAL::Block vector: v2: -DEAL::[block 0 ] 1.0 1.0 -DEAL::[block 1 ] 1.0 1.0 -DEAL::Block vector: v1: -DEAL::[block 0 ] 0.0 0.0 -DEAL::[block 1 ] 2.0 3.0 -DEAL::Block vector: v2: -DEAL::[block 0 ] 0.0 0.0 -DEAL::[block 1 ] 2.0 3.0 -DEAL::Block vector: v1: -DEAL::[block 0 ] 5.0 8.0 -DEAL::[block 1 ] 0.0 0.0 -DEAL::Block vector: v2: -DEAL::[block 0 ] 5.0 8.0 -DEAL::[block 1 ] 0.0 0.0 -DEAL::Block vector: v1: -DEAL::[block 0 ] 1.0 1.0 -DEAL::[block 1 ] 3.0 4.0 -DEAL::Block vector: v2: -DEAL::[block 0 ] 1.0 1.0 -DEAL::[block 1 ] 3.0 4.0 -DEAL::Block vector: v1: -DEAL::[block 0 ] 6.0 9.0 -DEAL::[block 1 ] 1.0 1.0 -DEAL::Block vector: v2: -DEAL::[block 0 ] 6.0 9.0 -DEAL::[block 1 ] 1.0 1.0