--- /dev/null
+############################################################
+# $Id$
+# Copyright (C) 2000, 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
+############################################################
+
+############################################################
+# Include general settings for including DEAL libraries
+############################################################
+
+include ../Makefile.paths
+include $D/common/Make.global_options
+debug-mode = on
+
+libraries = $(lib-lac.g) \
+ $(lib-base.g)
+libraries_o = $(lib-lac.o) \
+ $(lib-base.o)
+
+default: run-tests
+
+############################################################
+
+tests_x = tridiagonal_ev1
+
+
+# from above list of regular expressions, generate the real set of
+# tests
+expand = $(shell echo $(addsuffix .cc,$(1)) \
+ | $(PERL) -pi -e 's/\.cc//g;')
+tests = $(call expand,$(tests_x))
+
+############################################################
+
+
+include ../Makefile.rules
+include Makefile.depend
+include Makefile.tests
+
+.PHONY: default
\ No newline at end of file
--- /dev/null
+//--------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2006 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//--------------------------------------------------------------------
+
+// Tests compute_eigenvalues() and eigenvalue() of TridiagonalMatrix
+
+#include "../tests.h"
+#include <base/logstream.h>
+#include <lac/tridiagonal_matrix.h>
+#include <lac/vector.h>
+
+#include <fstream>
+#include <iostream>
+
+
+template <typename number>
+void test_laplacian(unsigned int n)
+{
+ TridiagonalMatrix<number> M(n, true);
+ for (unsigned int i=0;i<n-1;++i)
+ {
+ M(i,i) = 2.;
+ M(i,i+1) = -1.;
+ }
+ M(n-1,n-1) = 2.;
+
+ M.compute_eigenvalues();
+ for (unsigned int i=0;i<n;++i)
+ deallog << i << '\t' << M.eigenvalue(i);
+}
+
+
+int main()
+{
+ std::ofstream logfile("tridiagonal_ev1/output");
+ deallog.attach(logfile);
+ deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
+
+ test_laplacian<double>(50);
+}
--- /dev/null
+
+DEAL:Rect::operator= (const FullMatrix<number>&) ok
+DEAL:Rect::vmult ok
+DEAL:Rect::vmult_add ok
+DEAL:Rect::Tvmult ok
+DEAL:Rect::Tvmult_add ok
+DEAL::Eigenvalues 5 0
+DEAL::Eigenvalues 1 0
+DEAL::Eigenvalues 5 0
+DEAL::Eigenvalues 5 0