--- /dev/null
+//---------------------------------------------------------------------------
+// $Id: 3d_refinement_01.cc 29075 2013-03-27 15:07:57Z heister $
+// Version: $Name$
+//
+// Copyright (C) 2008, 2009 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.
+//
+//---------------------------------------------------------------------------
+
+
+// Test that we abort if you refine further than p4est::max_level
+
+#include "../tests.h"
+#include "coarse_grid_common.h"
+#include <deal.II/base/logstream.h>
+#include <deal.II/base/tensor.h>
+#include <deal.II/grid/tria.h>
+#include <deal.II/distributed/tria.h>
+#include <deal.II/grid/tria_accessor.h>
+#include <deal.II/grid/tria_iterator.h>
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/grid_out.h>
+
+#include <fstream>
+
+
+template<int dim>
+void test(std::ostream& /*out*/)
+{
+ parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD);
+
+ GridGenerator::hyper_cube(tr);
+ for (unsigned int i=0;i<19;++i)
+ {
+ deallog << "cells: " << tr.n_active_cells() << " level:" << tr.n_levels() << std::endl;
+
+ typename parallel::distributed::Triangulation<dim>::cell_iterator it;
+ it=tr.begin_active();
+ while (it->level()<static_cast<int>(i))
+ ++it;
+
+
+ it->set_refine_flag();
+ try
+ {
+ tr.execute_coarsening_and_refinement ();
+ }
+ catch (ExceptionBase &e)
+ {
+ deallog << e.get_exc_name() << std::endl;
+ }
+ }
+
+}
+
+
+int main(int argc, char *argv[])
+{
+ deal_II_exceptions::disable_abort_on_exception();
+ Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1);
+
+ std::ofstream logfile("3d_refinement_09/output");
+ deallog.attach(logfile);
+ deallog.depth_console(0);
+ deallog.threshold_double(1.e-10);
+
+ deallog.push("3d");
+ test<3>(logfile);
+ deallog.pop();
+}
--- /dev/null
+
+DEAL:3d::cells: 1 level:1
+DEAL:3d::cells: 8 level:2
+DEAL:3d::cells: 15 level:3
+DEAL:3d::cells: 22 level:4
+DEAL:3d::cells: 29 level:5
+DEAL:3d::cells: 36 level:6
+DEAL:3d::cells: 43 level:7
+DEAL:3d::cells: 50 level:8
+DEAL:3d::cells: 57 level:9
+DEAL:3d::cells: 64 level:10
+DEAL:3d::cells: 71 level:11
+DEAL:3d::cells: 78 level:12
+DEAL:3d::cells: 85 level:13
+DEAL:3d::cells: 92 level:14
+DEAL:3d::cells: 99 level:15
+DEAL:3d::cells: 106 level:16
+DEAL:3d::cells: 113 level:17
+DEAL:3d::cells: 120 level:18
+DEAL:3d::cells: 127 level:19
+DEAL:3d::ExcMessage("Fatal Error: maximum refinement level of p4est reached.")