]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove the ala_01 test. 940/head
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Sun, 17 May 2015 18:22:15 +0000 (13:22 -0500)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Sun, 17 May 2015 18:22:15 +0000 (13:22 -0500)
This tests checks the construction of generic sequential vectors.
It currently fails because the sequential PETSc and Trilinos
vectors were deprecated and their corresponding typedefs in
the dealii::LinearAlgebra* namespaces removed.

tests/lac/ala_01.cc [deleted file]
tests/lac/ala_01.with_trilinos=true.with_petsc=true.output [deleted file]

diff --git a/tests/lac/ala_01.cc b/tests/lac/ala_01.cc
deleted file mode 100644 (file)
index 32e3ce8..0000000
+++ /dev/null
@@ -1,80 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2004 - 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 contructing vectors
-
-#include "../tests.h"
-#include <deal.II/base/utilities.h>
-#include <deal.II/lac/generic_linear_algebra.h>
-#include <fstream>
-#include <iostream>
-
-template <class VEC>
-void test ()
-{
-  VEC x(3);
-  x(0)=10;
-  deallog << x.l2_norm() << std::endl;
-  x.compress(VectorOperation::insert);
-
-  deallog << "OK" << std::endl;
-}
-
-
-
-int main (int argc,char **argv)
-{
-  std::ofstream logfile("output");
-  deallog.attach(logfile);
-  deallog.depth_console(0);
-  deallog.threshold_double(1.e-10);
-
-  Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, 1);
-
-  try
-    {
-      {
-        test<dealii::LinearAlgebraPETSc::Vector> ();
-        test<dealii::LinearAlgebraDealII::Vector> ();
-        test<dealii::LinearAlgebraTrilinos::Vector> ();
-      }
-    }
-  catch (std::exception &exc)
-    {
-      std::cerr << std::endl << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      std::cerr << "Exception on processing: " << std::endl
-                << exc.what() << std::endl
-                << "Aborting!" << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-
-      return 1;
-    }
-  catch (...)
-    {
-      std::cerr << std::endl << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      std::cerr << "Unknown exception!" << std::endl
-                << "Aborting!" << std::endl
-                << "----------------------------------------------------"
-                << std::endl;
-      return 1;
-    };
-}
diff --git a/tests/lac/ala_01.with_trilinos=true.with_petsc=true.output b/tests/lac/ala_01.with_trilinos=true.with_petsc=true.output
deleted file mode 100644 (file)
index fb5aed2..0000000
+++ /dev/null
@@ -1,7 +0,0 @@
-
-DEAL::10.0000
-DEAL::OK
-DEAL::10.0000
-DEAL::OK
-DEAL::10.0000
-DEAL::OK

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.