+++ /dev/null
-############################################################
-# Makefile,v 1.15 2002/06/13 12:51:13 hartmann Exp
-# 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-deal2-1d.g) \
- $(lib-deal2-2d.g) \
- $(lib-deal2-3d.g) \
- $(lib-lac.g) \
- $(lib-base.g)
-
-default: run-tests
-
-############################################################
-
-tests_x = row_length_*
-
-# tests for the hp branch:
-# fe_collection_*
-
-ifeq ($(USE_CONTRIB_PETSC),yes)
- tests_x += petsc_*
-endif
-
-ifeq ($(USE_CONTRIB_METIS),yes)
- tests_x += metis_*
-endif
-
-ifeq ($(USE_CONTRIB_HSL),yes)
- tests_x += hsl_*
-endif
-
-ifeq ($(USE_CONTRIB_UMFPACK),yes)
- tests_x += umfpack_*
-endif
-
-
-# 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
+++ /dev/null
-//----------------------------------------------------------------------
-// $Id$
-// Version: $Name$
-//
-// Copyright (C) 2003, 2004, 2005, 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.
-//
-//----------------------------------------------------------------------
-
-#include "../lib/dof_tools_frame.h"
-#include "../lib/test_grids.h"
-
-#include <lac/sparsity_pattern.h>
-#include <numeric>
-
-template <int dim>
-void
-check_this (const DoFHandler<dim> &dof)
-{
- const unsigned int n = dof.n_dofs();
- deallog << "dofs: " << n
- << "\tcell: " << dof.get_fe().dofs_per_cell
- << std::endl;
-
- std::vector<unsigned int> row_length(n);
- DoFTools::compute_row_length_vector(dof, row_length);
- SparsityPattern sparsity(n, n, row_length);
- DoFTools::make_sparsity_pattern(dof, sparsity);
- sparsity.compress();
- unsigned int sum = std::accumulate(row_length.begin(), row_length.end(), 0U);
- deallog << std::endl << "Entries estimated/actual " << sum
- << '/' << sparsity.n_nonzero_elements() << std::endl;
-// sparsity.clear();
- output_vector(row_length);
-
- DoFTools::compute_row_length_vector(dof, row_length, DoFTools::always);
- output_vector(row_length);
-}
-
-
-template <int dim>
-void check()
-{
- Triangulation<dim> tr;
- TestGrids::hypercube(tr);
- deallog << "cube" << dim << std::endl;
- check_grid(tr);
- tr.refine_global(1);
- deallog << "refined cube" << dim << std::endl;
- check_grid(tr);
-}
-
-
-int
-main()
-{
- try
- {
- std::ofstream logfile("row_length_01/output");
- logfile.precision (2);
- deallog.attach(logfile);
-// deallog.depth_console(0);
- deallog.threshold_double(1.e-10);
- check<2>();
- return 0;
- }
- 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;
- };
-}
-