]> https://gitweb.dealii.org/ - dealii.git/commitdiff
removing test that requires lower triangular matrix
authorESeNonFossiIo <esenonfossiio@gmail.com>
Tue, 16 Jun 2015 20:33:47 +0000 (22:33 +0200)
committerESeNonFossiIo <esenonfossiio@gmail.com>
Thu, 25 Jun 2015 13:48:09 +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]

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 f4633ca..0000000
+++ /dev/null
@@ -1,40 +0,0 @@
-
-DEAL:: -- Matrix -- 
-DEAL::Block vector: v:
-DEAL::[block 0 ]  1.00000000000 
-DEAL::[block 1 ]  10.0000000000 
-DEAL::[block 2 ]  10.0000000000 
-DEAL::Block vector: v:
-DEAL::[block 0 ]  0.00000000000 
-DEAL::[block 1 ]  3.00000000000 
-DEAL::[block 2 ]  10.0000000000 
-DEAL::Block vector: v:
-DEAL::[block 0 ]  0.00000000000 
-DEAL::[block 1 ]  0.00000000000 
-DEAL::[block 2 ]  5.00000000000 
-DEAL:: -- Inverse -- 
-DEAL::Block vector: v:
-DEAL::[block 0 ]  1.00000000000 
-DEAL::[block 1 ]  -3.33333333333 
-DEAL::[block 2 ]  4.66666666667 
-DEAL::Block vector: v:
-DEAL::[block 0 ]  0.00000000000 
-DEAL::[block 1 ]  0.333333333333 
-DEAL::[block 2 ]  -0.666666666667 
-DEAL::Block vector: v:
-DEAL::[block 0 ]  0.00000000000 
-DEAL::[block 1 ]  0.00000000000 
-DEAL::[block 2 ]  0.200000000000 
-DEAL:: -- Identity -- 
-DEAL::Block vector: v:
-DEAL::[block 0 ]  1.00000000000 
-DEAL::[block 1 ]  0.00000000000 
-DEAL::[block 2 ]  0.00000000000 
-DEAL::Block vector: v:
-DEAL::[block 0 ]  0.00000000000 
-DEAL::[block 1 ]  1.00000000000 
-DEAL::[block 2 ]  0.00000000000 
-DEAL::Block vector: v:
-DEAL::[block 0 ]  0.00000000000 
-DEAL::[block 1 ]  0.00000000000 
-DEAL::[block 2 ]  1.00000000000 

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.