]> https://gitweb.dealii.org/ - dealii.git/commitdiff
removing tests that require upper and lower triangular block operators
authorESeNonFossiIo <esenonfossiio@gmail.com>
Tue, 16 Jun 2015 19:44:38 +0000 (21:44 +0200)
committerESeNonFossiIo <esenonfossiio@gmail.com>
Thu, 25 Jun 2015 13:48:08 +0000 (15:48 +0200)
tests/lac/block_linear_operator_03.cc [deleted file]
tests/lac/block_linear_operator_03.with_cxx11=on.output [deleted file]
tests/lac/block_linear_operator_04.cc [deleted file]
tests/lac/block_linear_operator_04.with_cxx11=on.output [deleted file]
tests/lac/block_linear_operator_05.cc [deleted file]
tests/lac/block_linear_operator_05.with_cxx11=on.output [deleted file]
tests/lac/block_linear_operator_07.cc [deleted file]
tests/lac/block_linear_operator_07.with_cxx11=on.output [deleted file]
tests/lac/block_linear_operator_08.cc [deleted file]
tests/lac/block_linear_operator_08.with_cxx11=on.output [deleted file]

diff --git a/tests/lac/block_linear_operator_03.cc b/tests/lac/block_linear_operator_03.cc
deleted file mode 100644 (file)
index dad87eb..0000000
+++ /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 <deal.II/lac/block_linear_operator.h>
-#include <deal.II/lac/block_sparse_matrix.h>
-#include <deal.II/lac/block_vector.h>
-#include <deal.II/lac/dynamic_sparsity_pattern.h>
-#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/vector.h>
-
-#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<double> 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<BlockVector<double>>(a);
-    auto triangular_block_op = lower_triangular_operator<3, BlockVector<double>, BlockVector<double>, BlockSparseMatrix<double> >(a);
-
-    BlockVector<double> u;
-    op_a.reinit_domain_vector(u, false);
-    BlockVector<double> 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 (file)
index 1507567..0000000
+++ /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 (file)
index 7b20530..0000000
+++ /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 <deal.II/lac/block_linear_operator.h>
-#include <deal.II/lac/block_sparse_matrix.h>
-#include <deal.II/lac/block_vector.h>
-#include <deal.II/lac/dynamic_sparsity_pattern.h>
-#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/vector.h>
-
-#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<double> 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<BlockVector<double>>(a);
-
-    auto triangular_block_op = upper_triangular_operator<3, BlockVector<double>, BlockVector<double>, BlockSparseMatrix<double> >(a);
-
-    BlockVector<double> u;
-    op_a.reinit_domain_vector(u, false);
-    BlockVector<double> 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 (file)
index 822b437..0000000
+++ /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 (file)
index b4373fb..0000000
+++ /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 <deal.II/lac/block_linear_operator.h>
-#include <deal.II/lac/block_sparse_matrix.h>
-#include <deal.II/lac/block_vector.h>
-#include <deal.II/lac/dynamic_sparsity_pattern.h>
-#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/vector.h>
-
-#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<double> 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<BlockVector<double>>(a);
-
-    auto lower_triangular_block_op = lower_triangular_operator<3, BlockVector<double>, BlockVector<double>, BlockSparseMatrix<double> >(a);
-    auto upper_triangular_block_op = upper_triangular_operator<3, BlockVector<double>, BlockVector<double>, BlockSparseMatrix<double> >(a);
-
-
-    BlockVector<double> u1;
-    op_a.reinit_domain_vector(u1, false);
-    BlockVector<double> v1;
-    op_a.reinit_range_vector(v1, false);
-    BlockVector<double> u2;
-    op_a.reinit_domain_vector(u2, false);
-    BlockVector<double> 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 (file)
index 476923c..0000000
+++ /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 (file)
index 91c7ead..0000000
+++ /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 <deal.II/lac/block_linear_operator.h>
-#include <deal.II/lac/block_sparse_matrix.h>
-#include <deal.II/lac/block_vector.h>
-#include <deal.II/lac/dynamic_sparsity_pattern.h>
-#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/vector.h>
-
-#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<double> &u1, BlockVector<double> &u2, BlockVector<double> &v1, BlockVector<double> &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<double> 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<BlockVector<double>>(a);
-
-    auto lower_triangular_block_op = lower_triangular_operator<2, BlockVector<double>, BlockVector<double>, BlockSparseMatrix<double>>(a);
-    auto upper_triangular_block_op = upper_triangular_operator<2, BlockVector<double>, BlockVector<double>, BlockSparseMatrix<double> >(a);
-
-
-    BlockVector<double> u1;
-    op_a.reinit_domain_vector(u1, false);
-    BlockVector<double> v1;
-    op_a.reinit_range_vector(v1, false);
-    BlockVector<double> u2;
-    op_a.reinit_domain_vector(u2, false);
-    BlockVector<double> 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 (file)
index 9d3ee42..0000000
+++ /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 (file)
index cd37399..0000000
+++ /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 <deal.II/lac/block_linear_operator.h>
-#include <deal.II/lac/block_sparse_matrix.h>
-#include <deal.II/lac/block_vector.h>
-#include <deal.II/lac/dynamic_sparsity_pattern.h>
-#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/vector.h>
-
-#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<double> &u1, BlockVector<double> &u2, BlockVector<double> &v1, BlockVector<double> &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<double> 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<double>,Vector<double>>(a.block(0,0));
-    auto op01 = linear_operator<Vector<double>,Vector<double>>(a.block(0,1));
-    auto op10 = linear_operator<Vector<double>,Vector<double>>(a.block(1,0));
-    auto op11 = linear_operator<Vector<double>,Vector<double>>(a.block(1,1));
-
-    auto lower_triangular_block_op =
-          lower_triangular_operator<  2,
-                                      BlockVector<double>,
-                                      BlockVector<double>>({{
-      {{ op00, op01 }} ,
-      {{ op10, op11 }}
-    }
-  });
-    auto upper_triangular_block_op =
-          upper_triangular_operator<  2,
-                                      BlockVector<double>,
-                                      BlockVector<double>>({{
-      {{ op00, op01 }} ,
-      {{ op10, op11 }}
-    }
-  });
-
-    BlockVector<double> u1;
-    lower_triangular_block_op.reinit_domain_vector(u1, false);
-    BlockVector<double> v1;
-    lower_triangular_block_op.reinit_range_vector(v1, false);
-    BlockVector<double> u2;
-    upper_triangular_block_op.reinit_domain_vector(u2, false);
-    BlockVector<double> 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 (file)
index 9d3ee42..0000000
+++ /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    

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.