]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Deleted old files product_matrix_01.cc and product_matrix_01.output
authordakshina.ilangova <dakshina.ilangova@0785d39b-7218-0410-832d-ea1e28bc413d>
Sat, 8 Mar 2014 19:40:25 +0000 (19:40 +0000)
committerdakshina.ilangova <dakshina.ilangova@0785d39b-7218-0410-832d-ea1e28bc413d>
Sat, 8 Mar 2014 19:40:25 +0000 (19:40 +0000)
git-svn-id: https://svn.dealii.org/trunk@32627 0785d39b-7218-0410-832d-ea1e28bc413d

tests/lac/product_matrix_01.cc [deleted file]
tests/lac/product_matrix_01.output [deleted file]

diff --git a/tests/lac/product_matrix_01.cc b/tests/lac/product_matrix_01.cc
deleted file mode 100644 (file)
index 271998f..0000000
+++ /dev/null
@@ -1,80 +0,0 @@
-// ---------------------------------------------------------------------
-// $Id$
-//
-// Copyright (C) 2014 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 ProductMatrix::vmult
-
-
-#include "../tests.h"
-#include <deal.II/base/logstream.h>
-#include <deal.II/lac/matrix_lib.h>
-#include <deal.II/lac/full_matrix.h>
-#include <deal.II/lac/vector.h>
-
-#include <fstream>
-#include <iomanip>
-#include <cmath>
-
-template<typename number>
-void
-check()
-{
-  const double Adata[] =
-    {
-         2, 3,
-         4, 5
-    };
-
-  const double Bdata[] =
-    {
-         0, 1,
-         2, 3
-    };
-
-
-  FullMatrix<float> A(2,2);
-  FullMatrix<double> B(2,2);
-
-  A.fill(Adata);
-  B.fill(Bdata);
-
-  GrowingVectorMemory<Vector<number> > mem;
-
-  ProductMatrix<Vector<number> > AB(A,B,mem);
-
-  Vector<number> u(2);
-  Vector<number> v(2);
-
-  u(0) = 1.;
-  u(1) = 2.;
-
-  AB.vmult(v,u);
-
-  deallog << v(0) << '\t' << v(1) << std::endl;
-}
-
-
-int main()
-{
-  std::ofstream logfile("output");
-  deallog << std::setprecision(4);
-  deallog.attach(logfile);
-  deallog.depth_console(0);
-  deallog.threshold_double(1.e-10);
-
-  check<double>();
-  check<float>();
-}
diff --git a/tests/lac/product_matrix_01.output b/tests/lac/product_matrix_01.output
deleted file mode 100644 (file)
index bb1ca41..0000000
+++ /dev/null
@@ -1,3 +0,0 @@
-
-DEAL::28.00    48.00
-DEAL::28.00    48.00

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.