// ---------------------------------------------------------------------
//
-// Copyright (C) 2005 - 2015 by the deal.II authors
+// Copyright (C) 2005 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
template <int dim>
LaplaceProblem<dim>::LaplaceProblem () :
+ triangulation(limit_level_difference_at_vertices),
fe (1),
mg_dof_handler (triangulation)
{}
// ---------------------------------------------------------------------
//
-// Copyright (C) 2009 - 2015 by the deal.II authors
+// Copyright (C) 2009 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
template<int dim>
void test_fe (const FiniteElement<dim> &fe)
{
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(5-dim);
test_grid(tr, fe);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2009 - 2015 by the deal.II authors
+// Copyright (C) 2009 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
template<int dim>
void test_fe (const FiniteElement<dim> &fe)
{
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(5-dim);
test_grid(tr, fe);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2011 - 2015 by the deal.II authors
+// Copyright (C) 2011 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
void (*test_block_list)(const TR &tr, const FiniteElement<TR::dimension> &fe))
{
const unsigned int dim=TR::dimension;
- TR trc, trl;
+ TR trc(Triangulation<dim>::limit_level_difference_at_vertices);
+ TR trl(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(trc);
trc.refine_global(2);
GridGenerator::hyper_L(trl);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2009 - 2015 by the deal.II authors
+// Copyright (C) 2009 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
void test_global_refinement(
void (*test_block_list)(const Triangulation<dim> &tr, const FiniteElement<dim> &fe))
{
- Triangulation<dim> trc, trl;
+ Triangulation<dim> trc(Triangulation<dim>::limit_level_difference_at_vertices);
+ Triangulation<dim> trl(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(trc);
trc.refine_global(2);
GridGenerator::hyper_L(trl);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
void
check ()
{
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
if (dim==2)
GridGenerator::hyper_ball(tr, Point<dim>(), 1);
else
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
void
check ()
{
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr, -1., 1.);
tr.refine_global (1);
tr.begin_active()->set_refine_flag ();
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
void
check ()
{
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr, -1., 1.);
tr.refine_global (1);
tr.begin_active()->set_refine_flag ();
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
void
check ()
{
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr, -1., 1.);
tr.refine_global (1);
tr.begin_active()->set_refine_flag ();
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
void
check ()
{
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>:: limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr, -1,1);
tr.refine_global (1);
tr.begin_active()->set_refine_flag();
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
void
check ()
{
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>:: limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr, -1,1);
tr.refine_global (1);
tr.begin_active()->set_refine_flag();
// ---------------------------------------------------------------------
//
-// Copyright (C) 1998 - 2015 by the deal.II authors
+// Copyright (C) 1998 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
deallog << std::setprecision(7);
deallog.threshold_double(1.e-10);
- Triangulation<2> tr2;
+ Triangulation<2> tr2(Triangulation<2>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr2, -1., 1.);
tr2.refine_global(2);
- Triangulation<3> tr3;
+ Triangulation<3> tr3(Triangulation<3>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr3, -1., 1.);
tr3.refine_global(3);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2012 - 2015 by the deal.II authors
+// Copyright (C) 2012 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>:: limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(1);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2012 - 2015 by the deal.II authors
+// Copyright (C) 2012 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>:: limit_level_difference_at_vertices);
std::vector<unsigned int> repititions (dim, 1);
repititions[0] = 2;
const Point<dim> p1 = (dim == 1 ? Point<dim> (-1.) : (dim == 2 ? Point<dim>(-1.,-1.) : Point<dim> (-1.,-1.,-1.)));
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
void
test(const FiniteElement<dim> &fe)
{
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
DoFHandler<dim> dofs(tr);
GridGenerator::hyper_cube(tr);
tr.refine_global(1);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
void
test(const FiniteElement<dim> &fe)
{
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
DoFHandler<dim> dofs(tr);
GridGenerator::hyper_cube(tr);
tr.refine_global(1);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
void
test(const FiniteElement<dim> &fe)
{
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(1);
tr.begin(1)->set_refine_flag();
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
void
test(const FiniteElement<dim> &fe)
{
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_L(tr);
tr.begin()->set_refine_flag();
tr.execute_coarsening_and_refinement();
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
test(const FiniteElement<dim> &fe)
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_L(tr);
tr.begin()->set_refine_flag();
tr.execute_coarsening_and_refinement();
void test ()
{
const SphericalManifold<dim> manifold;
- Triangulation<dim> tria;
+ Triangulation<dim> tria(Triangulation<dim>:: limit_level_difference_at_vertices);
GridGenerator::hyper_ball (tria);
typename Triangulation<dim>::active_cell_iterator
cell = tria.begin_active (),
// ---------------------------------------------------------------------
//
-// Copyright (C) 2014 - 2016-2015 by the deal.II authors
+// Copyright (C) 2014 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
for (unsigned int i=5; i<8; ++i)
{
parallel::distributed::Triangulation<dim> tria(MPI_COMM_WORLD,
- dealii::Triangulation<dim>::none,parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
+ Triangulation<dim>::limit_level_difference_at_vertices,
+ parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
GridGenerator::hyper_cube (tria);
tria.refine_global(i-dim);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2014 - 2016-2015 by the deal.II authors
+// Copyright (C) 2014 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
void test ()
{
parallel::distributed::Triangulation<dim> tria(MPI_COMM_WORLD,
- dealii::Triangulation<dim>::none,parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
+ Triangulation<dim>::limit_level_difference_at_vertices,
+ parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
GridGenerator::hyper_cube (tria);
tria.refine_global(6-dim);
const unsigned int n_runs = fe_degree == 1 ? 6-dim : 5-dim;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2014 - 2016-2016 by the deal.II authors
+// Copyright (C) 2014 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
void test ()
{
parallel::distributed::Triangulation<dim> tria(MPI_COMM_WORLD,
- dealii::Triangulation<dim>::none,parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
+ Triangulation<dim>::limit_level_difference_at_vertices,
+ parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
GridGenerator::hyper_cube (tria);
tria.refine_global(8-2*dim);
const unsigned int n_runs = fe_degree == 1 ? 6-dim : 5-dim;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2014 - 2016-2016 by the deal.II authors
+// Copyright (C) 2014 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
for (unsigned int i=5; i<8; ++i)
{
parallel::distributed::Triangulation<dim> tria(MPI_COMM_WORLD,
- dealii::Triangulation<dim>::none,parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
+ Triangulation<dim>::limit_level_difference_at_vertices,
+ parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
GridGenerator::hyper_cube (tria);
tria.refine_global(i-dim);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2012 - 2015 by the deal.II authors
+// Copyright (C) 2012 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
template <int dim>
LaplaceProblem<dim>::LaplaceProblem ()
:
+ triangulation (Triangulation<dim>::limit_level_difference_at_vertices),
fe (degree_finite_element),
dof_handler (triangulation)
{}
// ---------------------------------------------------------------------
//
-// Copyright (C) 2009 - 2015 by the deal.II authors
+// Copyright (C) 2009 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
deallog << "hyper_cube" << std::endl;
parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD,
- Triangulation<dim>::none,
+ Triangulation<dim>:: limit_level_difference_at_vertices,
parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
GridGenerator::hyper_cube(tr);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2009 - 2015 by the deal.II authors
+// Copyright (C) 2009 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
deallog << "hyper_cube" << std::endl;
parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD,
- Triangulation<dim>::none,
+ Triangulation<dim>:: limit_level_difference_at_vertices,
parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
GridGenerator::hyper_cube(tr);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2009 - 2015 by the deal.II authors
+// Copyright (C) 2009 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
deallog << "hyper_cube" << std::endl;
parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD,
- Triangulation<dim>::none,
+ Triangulation<dim>:: limit_level_difference_at_vertices,
parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
GridGenerator::hyper_cube(tr);
tr.refine_global(2);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2009 - 2015 by the deal.II authors
+// Copyright (C) 2009 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD,
- Triangulation<dim>::none,
+ Triangulation<dim>:: limit_level_difference_at_vertices,
parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
GridGenerator::hyper_cube(tr);
tr.refine_global(3);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2009 - 2015 by the deal.II authors
+// Copyright (C) 2009 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD,
- Triangulation<dim>::none,
+ Triangulation<dim>:: limit_level_difference_at_vertices,
parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
GridGenerator::hyper_cube_slit(tr,-1,1);
tr.refine_global(2);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2015 - 2015 by the deal.II authors
+// Copyright (C) 2015 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
void test()
{
parallel::distributed::Triangulation<dim> tria(MPI_COMM_WORLD,
- Triangulation<dim>::none,
+ Triangulation<dim>:: limit_level_difference_at_vertices,
parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
std::vector<unsigned int> subdivisions(dim);
Point<dim> p1, p2;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2015 - 2015 by the deal.II authors
+// Copyright (C) 2015 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
Assert(dim == 3, ExcNotImplemented());
parallel::distributed::Triangulation<dim> tria(MPI_COMM_WORLD,
- Triangulation<dim>::none,
+ Triangulation<dim>:: limit_level_difference_at_vertices,
parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
GridGenerator::hyper_cube(tria, 0, 1);
for (unsigned int face=2; face<GeometryInfo<dim>::faces_per_cell; ++face)
// ---------------------------------------------------------------------
//
-// Copyright (C) 2015 - 2015 by the deal.II authors
+// Copyright (C) 2015 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
Assert(dim == 2, ExcNotImplemented());
parallel::distributed::Triangulation<dim> tria(MPI_COMM_WORLD,
- Triangulation<dim>::none,
+ Triangulation<dim>:: limit_level_difference_at_vertices,
parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
for (unsigned int run=0; run<2; ++run)
{
// ---------------------------------------------------------------------
//
-// Copyright (C) 2015 - 2015 by the deal.II authors
+// Copyright (C) 2015 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
void test()
{
parallel::distributed::Triangulation<dim> tria(MPI_COMM_WORLD,
- Triangulation<dim>::none,
+ Triangulation<dim>:: limit_level_difference_at_vertices,
parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
std::vector<unsigned int> subdivisions(dim);
Point<dim> p1, p2;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2006 - 2015 by the deal.II authors
+// Copyright (C) 2006 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(2);
ZeroFunction<dim> zero;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2006 - 2015 by the deal.II authors
+// Copyright (C) 2006 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
deallog << fe.get_name() << std::endl;
parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD,
- Triangulation<dim>::none,
+ Triangulation<dim>::limit_level_difference_at_vertices,
parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
setup_tria(tr);
{
// reorder
parallel::distributed::Triangulation<dim> tr(MPI_COMM_SELF,
- Triangulation<dim>::none,
+ Triangulation<dim>::limit_level_difference_at_vertices,
parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
setup_tria(tr);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2006 - 2015 by the deal.II authors
+// Copyright (C) 2006 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
deallog << fe.get_name() << std::endl;
parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD,
- Triangulation<dim>::none,
+ Triangulation<dim>::limit_level_difference_at_vertices,
parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
setup_tria(tr);
{
// reorder
parallel::distributed::Triangulation<dim> tr(MPI_COMM_SELF,
- Triangulation<dim>::none,
+ Triangulation<dim>::limit_level_difference_at_vertices,
parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
setup_tria(tr);
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(1);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2006 - 2015 by the deal.II authors
+// Copyright (C) 2006 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(1);
tr.begin_active()->set_refine_flag();
// ---------------------------------------------------------------------
//
-// Copyright (C) 2006 - 2015 by the deal.II authors
+// Copyright (C) 2006 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
deallog << "Testing " << fe.get_name() << std::endl << std::endl;
parallel::distributed::Triangulation<dim> triangulation
(MPI_COMM_WORLD,
- Triangulation<dim>::none,
+ Triangulation<dim>::limit_level_difference_at_vertices,
parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
GridGenerator::subdivided_hyper_cube (triangulation, 1, -1, 1);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2006 - 2015 by the deal.II authors
+// Copyright (C) 2006 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(2);
ZeroFunction<dim> zero;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2006 - 2015 by the deal.II authors
+// Copyright (C) 2006 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(2);
ZeroFunction<dim> zero;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2006 - 2015 by the deal.II authors
+// Copyright (C) 2006 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
FE_Q<dim> fe(1);
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(1);
// need cubic polynomials that have two dofs on lines
FE_Q<dim> fe(3);
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
if (dim > 1)
GridGenerator::hyper_shell(tr, Point<dim>(), 0.5, 1, 12);
else
// need cubic polynomials that have two dofs on lines
FE_Q<dim> fe(3);
- parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD, Triangulation<dim>::none,
+ parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD, Triangulation<dim>::limit_level_difference_at_vertices,
parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
GridGenerator::hyper_shell(tr, Point<dim>(), 0.5, 1, 12);
tr.refine_global(1);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
FESystem<dim> fe(FE_DGP<dim>(1), 1, FE_DGQ<dim>(2), 2, FE_Q<dim>(3), 1);
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(1);
tr.begin_active()->set_refine_flag();
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
FE_DGQ<dim> fe(1);
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tria;
+ Triangulation<dim> tria(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tria);
tria.refine_global(2);
typename Triangulation<dim>::active_cell_iterator cell=tria.begin_active();
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
FE_Q<dim> fe(3);
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tria;
+ Triangulation<dim> tria(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tria);
tria.refine_global(2);
typename Triangulation<dim>::active_cell_iterator cell=tria.begin_active();
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << std::endl << "**** " << fe.get_name() << std::endl;
- Triangulation<dim> tria;
+ Triangulation<dim> tria(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tria);
tria.refine_global(1);
tria.begin_active()->set_refine_flag();
// ---------------------------------------------------------------------
//
-// Copyright (C) 2013 - 2015 by the deal.II authors
+// Copyright (C) 2013 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
template <int dim>
InteriorPenaltyProblem<dim>::InteriorPenaltyProblem(const FiniteElement<dim> &fe)
:
+ triangulation(Triangulation<dim>::limit_level_difference_at_vertices),
mapping(1),
fe(fe),
dof_handler(triangulation),
DEAL::Assemble right hand side
DEAL::Solve
DEAL:cg::Starting value 23.0730
-DEAL:cg::Convergence step 11 value 9.37499e-13
+DEAL:cg::Convergence step 11 value 9.09099e-13
DEAL::energy-error: 0.332582
DEAL::L2-error: 0.00548996
DEAL::Estimate 0.838060
DEAL::Assemble right hand side
DEAL::Solve
DEAL:cg::Starting value 23.0730
-DEAL:cg::Convergence step 12 value 3.41649e-13
+DEAL:cg::Convergence step 12 value 1.66147e-13
DEAL::energy-error: 0.237705
DEAL::L2-error: 0.00250869
DEAL::Estimate 0.611449
DEAL::Step 3
-DEAL::Triangulation 58 cells, 5 levels
-DEAL::DoFHandler 522 dofs, level dofs 36 144 180 180 144
+DEAL::Triangulation 64 cells, 5 levels
+DEAL::DoFHandler 576 dofs, level dofs 36 144 216 216 144
DEAL::Assemble matrix
DEAL::Assemble multilevel matrix
DEAL::Assemble right hand side
DEAL::Solve
-DEAL:cg::Starting value 23.4898
-DEAL:cg::Convergence step 12 value 5.58516e-13
-DEAL::energy-error: 0.170860
-DEAL::L2-error: 0.00120805
-DEAL::Estimate 0.452418
+DEAL:cg::Starting value 24.1546
+DEAL:cg::Convergence step 13 value 2.19190e-13
+DEAL::energy-error: 0.170175
+DEAL::L2-error: 0.00120328
+DEAL::Estimate 0.448676
DEAL::Step 4
-DEAL::Triangulation 85 cells, 6 levels
-DEAL::DoFHandler 765 dofs, level dofs 36 144 360 180 180 108
+DEAL::Triangulation 91 cells, 6 levels
+DEAL::DoFHandler 819 dofs, level dofs 36 144 396 216 180 108
DEAL::Assemble matrix
DEAL::Assemble multilevel matrix
DEAL::Assemble right hand side
DEAL::Solve
-DEAL:cg::Starting value 25.9490
-DEAL:cg::Convergence step 13 value 2.71720e-13
-DEAL::energy-error: 0.122755
-DEAL::L2-error: 0.000602816
-DEAL::Estimate 0.332525
+DEAL:cg::Starting value 26.5522
+DEAL:cg::Convergence step 13 value 2.44978e-13
+DEAL::energy-error: 0.121878
+DEAL::L2-error: 0.000591777
+DEAL::Estimate 0.327296
DEAL::Step 5
-DEAL::Triangulation 130 cells, 7 levels
-DEAL::DoFHandler 1170 dofs, level dofs 36 144 432 432 180 180 144
+DEAL::Triangulation 142 cells, 7 levels
+DEAL::DoFHandler 1278 dofs, level dofs 36 144 432 432 288 216 144
DEAL::Assemble matrix
DEAL::Assemble multilevel matrix
DEAL::Assemble right hand side
DEAL::Solve
DEAL:cg::Starting value 27.1421
-DEAL:cg::Convergence step 13 value 2.50045e-13
-DEAL::energy-error: 0.0869445
-DEAL::L2-error: 0.000292783
-DEAL::Estimate 0.236647
+DEAL:cg::Convergence step 13 value 3.08737e-13
+DEAL::energy-error: 0.0863235
+DEAL::L2-error: 0.000292807
+DEAL::Estimate 0.232279
// ---------------------------------------------------------------------
//
-// Copyright (C) 2013 - 2015 by the deal.II authors
+// Copyright (C) 2013 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
template <int dim>
InteriorPenaltyProblem<dim>::InteriorPenaltyProblem(const FiniteElement<dim> &fe)
:
+ triangulation(Triangulation<dim>::limit_level_difference_at_vertices),
mapping(1),
fe(fe),
dof_handler(triangulation),
DEAL::Assemble right hand side
DEAL::Solve
DEAL:cg::Starting value 23.0730
-DEAL:cg::Convergence step 11 value 9.37499e-13
+DEAL:cg::Convergence step 11 value 9.09099e-13
DEAL::energy-error: 0.332582
DEAL::L2-error: 0.00548996
DEAL::Estimate 0.838060
DEAL::Assemble right hand side
DEAL::Solve
DEAL:cg::Starting value 23.0730
-DEAL:cg::Convergence step 12 value 3.41649e-13
+DEAL:cg::Convergence step 12 value 1.66147e-13
DEAL::energy-error: 0.237705
DEAL::L2-error: 0.00250869
DEAL::Estimate 0.611449
DEAL::Step 3
-DEAL::Triangulation 58 cells, 5 levels
-DEAL::DoFHandler 522 dofs, level dofs 36 144 180 180 144
+DEAL::Triangulation 64 cells, 5 levels
+DEAL::DoFHandler 576 dofs, level dofs 36 144 216 216 144
DEAL::Assemble matrix
DEAL::Assemble multilevel matrix
DEAL::Assemble right hand side
DEAL::Solve
-DEAL:cg::Starting value 23.4898
-DEAL:cg::Convergence step 12 value 5.58516e-13
-DEAL::energy-error: 0.170860
-DEAL::L2-error: 0.00120805
-DEAL::Estimate 0.452418
+DEAL:cg::Starting value 24.1546
+DEAL:cg::Convergence step 13 value 2.19190e-13
+DEAL::energy-error: 0.170175
+DEAL::L2-error: 0.00120328
+DEAL::Estimate 0.448676
DEAL::Step 4
-DEAL::Triangulation 85 cells, 6 levels
-DEAL::DoFHandler 765 dofs, level dofs 36 144 360 180 180 108
+DEAL::Triangulation 91 cells, 6 levels
+DEAL::DoFHandler 819 dofs, level dofs 36 144 396 216 180 108
DEAL::Assemble matrix
DEAL::Assemble multilevel matrix
DEAL::Assemble right hand side
DEAL::Solve
-DEAL:cg::Starting value 25.9490
-DEAL:cg::Convergence step 13 value 2.71720e-13
-DEAL::energy-error: 0.122755
-DEAL::L2-error: 0.000602816
-DEAL::Estimate 0.332525
+DEAL:cg::Starting value 26.5522
+DEAL:cg::Convergence step 13 value 2.44978e-13
+DEAL::energy-error: 0.121878
+DEAL::L2-error: 0.000591777
+DEAL::Estimate 0.327296
DEAL::Step 5
-DEAL::Triangulation 130 cells, 7 levels
-DEAL::DoFHandler 1170 dofs, level dofs 36 144 432 432 180 180 144
+DEAL::Triangulation 142 cells, 7 levels
+DEAL::DoFHandler 1278 dofs, level dofs 36 144 432 432 288 216 144
DEAL::Assemble matrix
DEAL::Assemble multilevel matrix
DEAL::Assemble right hand side
DEAL::Solve
DEAL:cg::Starting value 27.1421
-DEAL:cg::Convergence step 13 value 2.50045e-13
-DEAL::energy-error: 0.0869445
-DEAL::L2-error: 0.000292783
-DEAL::Estimate 0.236647
+DEAL:cg::Convergence step 13 value 3.08737e-13
+DEAL::energy-error: 0.0863235
+DEAL::L2-error: 0.000292807
+DEAL::Estimate 0.232279
// ---------------------------------------------------------------------
//
-// Copyright (C) 2013 - 2015 by the deal.II authors
+// Copyright (C) 2013 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
template <int dim>
InteriorPenaltyProblem<dim>::InteriorPenaltyProblem(const FiniteElement<dim> &fe)
:
+ triangulation(Triangulation<dim>::limit_level_difference_at_vertices),
mapping(1),
fe(fe),
dof_handler(triangulation),
DEAL::Assemble right hand side
DEAL::Solve
DEAL:GMRES::Starting value 9.41508
-DEAL:GMRES::Convergence step 10 value 7.45877e-13
+DEAL:GMRES::Convergence step 10 value 7.45878e-13
DEAL::energy-error: 0.439211
DEAL::L2-error: 0.0109342
DEAL::Estimate 0.979555
DEAL::Assemble right hand side
DEAL::Solve
DEAL:GMRES::Starting value 10.0041
-DEAL:GMRES::Convergence step 21 value 1.79028e-13
+DEAL:GMRES::Convergence step 21 value 1.79039e-13
DEAL::energy-error: 0.332582
DEAL::L2-error: 0.00548996
DEAL::Estimate 0.838060
DEAL::Assemble right hand side
DEAL::Solve
DEAL:GMRES::Starting value 10.8018
-DEAL:GMRES::Convergence step 28 value 2.71140e-13
+DEAL:GMRES::Convergence step 28 value 2.71098e-13
DEAL::energy-error: 0.237705
DEAL::L2-error: 0.00250869
DEAL::Estimate 0.611449
DEAL::Writing solution to <sol-02.gnuplot>...
DEAL::
DEAL::Step 3
-DEAL::Triangulation 58 cells, 5 levels
-DEAL::DoFHandler 840 dofs, level dofs 63 229 285 285 233
+DEAL::Triangulation 64 cells, 5 levels
+DEAL::DoFHandler 917 dofs, level dofs 63 229 337 337 233
DEAL::Assemble matrix
DEAL::Assemble multilevel matrix
DEAL::Assemble right hand side
DEAL::Solve
-DEAL:GMRES::Starting value 12.2055
-DEAL:GMRES::Convergence step 33 value 8.68786e-13
-DEAL::energy-error: 0.170860
-DEAL::L2-error: 0.00120805
-DEAL::Estimate 0.452418
+DEAL:GMRES::Starting value 13.4185
+DEAL:GMRES::Convergence step 32 value 6.11150e-13
+DEAL::energy-error: 0.170175
+DEAL::L2-error: 0.00120328
+DEAL::Estimate 0.448676
DEAL::Writing solution to <sol-03.gnuplot>...
DEAL::
DEAL::Step 4
-DEAL::Triangulation 85 cells, 6 levels
-DEAL::DoFHandler 1218 dofs, level dofs 63 229 561 285 285 177
+DEAL::Triangulation 91 cells, 6 levels
+DEAL::DoFHandler 1295 dofs, level dofs 63 229 613 337 285 177
DEAL::Assemble matrix
DEAL::Assemble multilevel matrix
DEAL::Assemble right hand side
DEAL::Solve
-DEAL:GMRES::Starting value 15.5679
-DEAL:GMRES::Convergence step 34 value 7.55616e-13
-DEAL::energy-error: 0.122755
-DEAL::L2-error: 0.000602816
-DEAL::Estimate 0.332525
+DEAL:GMRES::Starting value 16.6112
+DEAL:GMRES::Convergence step 32 value 7.81623e-13
+DEAL::energy-error: 0.121878
+DEAL::L2-error: 0.000591777
+DEAL::Estimate 0.327296
DEAL::Writing solution to <sol-04.gnuplot>...
DEAL::
DEAL::Step 5
-DEAL::Triangulation 130 cells, 7 levels
-DEAL::DoFHandler 1841 dofs, level dofs 63 229 665 665 285 285 233
+DEAL::Triangulation 142 cells, 7 levels
+DEAL::DoFHandler 2005 dofs, level dofs 63 229 665 665 449 337 233
DEAL::Assemble matrix
DEAL::Assemble multilevel matrix
DEAL::Assemble right hand side
DEAL::Solve
-DEAL:GMRES::Starting value 18.7682
-DEAL:GMRES::Convergence step 33 value 8.65709e-13
-DEAL::energy-error: 0.0869445
-DEAL::L2-error: 0.000292783
-DEAL::Estimate 0.236647
+DEAL:GMRES::Starting value 19.3095
+DEAL:GMRES::Convergence step 31 value 8.40512e-13
+DEAL::energy-error: 0.0863235
+DEAL::L2-error: 0.000292807
+DEAL::Estimate 0.232279
DEAL::Writing solution to <sol-05.gnuplot>...
DEAL::
// ---------------------------------------------------------------------
//
-// Copyright (C) 2010 - 2015 by the deal.II authors
+// Copyright (C) 2010 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
template <int dim>
InteriorPenaltyProblem<dim>::InteriorPenaltyProblem(const FiniteElement<dim> &fe)
:
+ triangulation(Triangulation<dim>::limit_level_difference_at_vertices),
mapping(1),
fe(fe),
dof_handler(triangulation),
DEAL::Assemble right hand side
DEAL::Solve
DEAL:cg::Starting value 23.0730
-DEAL:cg::Convergence step 11 value 9.37499e-13
+DEAL:cg::Convergence step 11 value 9.09099e-13
DEAL::energy-error: 0.332582
DEAL::L2-error: 0.00548996
DEAL::Estimate 0.838060
DEAL::Assemble right hand side
DEAL::Solve
DEAL:cg::Starting value 23.0730
-DEAL:cg::Convergence step 12 value 3.41649e-13
+DEAL:cg::Convergence step 12 value 1.66147e-13
DEAL::energy-error: 0.237705
DEAL::L2-error: 0.00250869
DEAL::Estimate 0.611449
DEAL::Step 3
-DEAL::Triangulation 58 cells, 5 levels
-DEAL::DoFHandler 522 dofs, level dofs 36 144 180 180 144
+DEAL::Triangulation 64 cells, 5 levels
+DEAL::DoFHandler 576 dofs, level dofs 36 144 216 216 144
DEAL::Assemble matrix
DEAL::Assemble multilevel matrix
DEAL::Assemble right hand side
DEAL::Solve
-DEAL:cg::Starting value 23.4898
-DEAL:cg::Convergence step 12 value 5.58516e-13
-DEAL::energy-error: 0.170860
-DEAL::L2-error: 0.00120805
-DEAL::Estimate 0.452418
+DEAL:cg::Starting value 24.1546
+DEAL:cg::Convergence step 13 value 2.19190e-13
+DEAL::energy-error: 0.170175
+DEAL::L2-error: 0.00120328
+DEAL::Estimate 0.448676
DEAL::Step 4
-DEAL::Triangulation 85 cells, 6 levels
-DEAL::DoFHandler 765 dofs, level dofs 36 144 360 180 180 108
+DEAL::Triangulation 91 cells, 6 levels
+DEAL::DoFHandler 819 dofs, level dofs 36 144 396 216 180 108
DEAL::Assemble matrix
DEAL::Assemble multilevel matrix
DEAL::Assemble right hand side
DEAL::Solve
-DEAL:cg::Starting value 25.9490
-DEAL:cg::Convergence step 13 value 2.71720e-13
-DEAL::energy-error: 0.122755
-DEAL::L2-error: 0.000602816
-DEAL::Estimate 0.332525
+DEAL:cg::Starting value 26.5522
+DEAL:cg::Convergence step 13 value 2.44978e-13
+DEAL::energy-error: 0.121878
+DEAL::L2-error: 0.000591777
+DEAL::Estimate 0.327296
DEAL::Step 5
-DEAL::Triangulation 130 cells, 7 levels
-DEAL::DoFHandler 1170 dofs, level dofs 36 144 432 432 180 180 144
+DEAL::Triangulation 142 cells, 7 levels
+DEAL::DoFHandler 1278 dofs, level dofs 36 144 432 432 288 216 144
DEAL::Assemble matrix
DEAL::Assemble multilevel matrix
DEAL::Assemble right hand side
DEAL::Solve
DEAL:cg::Starting value 27.1421
-DEAL:cg::Convergence step 13 value 2.50045e-13
-DEAL::energy-error: 0.0869445
-DEAL::L2-error: 0.000292783
-DEAL::Estimate 0.236647
+DEAL:cg::Convergence step 13 value 3.08737e-13
+DEAL::energy-error: 0.0863235
+DEAL::L2-error: 0.000292807
+DEAL::Estimate 0.232279
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(2);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
refine_mesh(tr);
refine_mesh(tr);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2006 - 2015 by the deal.II authors
+// Copyright (C) 2006 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
deallog << fe.get_name() << std::endl;
parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD,
- Triangulation<dim>::none,
+ Triangulation<dim>::limit_level_difference_at_vertices,
parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
setup_tria(tr);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2006 - 2015 by the deal.II authors
+// Copyright (C) 2006 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
deallog << fe.get_name() << std::endl;
parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD,
- Triangulation<dim>::none,
+ Triangulation<dim>::limit_level_difference_at_vertices,
parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
setup_tria(tr);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
deallog << ' ' << i;
deallog << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(2);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
deallog << fe.get_name()
<< " select " << selected << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(2);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
deallog << fe.get_name() << std::endl;
std::vector<bool> selected(fe.n_blocks(), true);
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(2);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(1);
tr.begin_active()->set_refine_flag();
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(1);
tr.begin_active()->set_refine_flag();
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(1);
tr.begin_active()->set_refine_flag();
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
<< " (global) and " << mg_selected
<< " (mg)" << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(2);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(2);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(2);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(2);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(2);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
GridGenerator::hyper_cube(tr);
tr.refine_global(2);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
std::vector<unsigned int> subdivisions (dim, 1);
subdivisions[0] = 2;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
std::vector<unsigned int> subdivisions (dim, 1);
subdivisions[0] = 2;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
std::vector<unsigned int> subdivisions (dim, 1);
subdivisions[0] = 2;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
std::vector<unsigned int> subdivisions (dim, 1);
subdivisions[0] = 2;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
std::vector<unsigned int> subdivisions (dim, 1);
subdivisions[0] = 2;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
std::vector<unsigned int> subdivisions (dim, 1);
subdivisions[0] = 2;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
std::vector<unsigned int> subdivisions (dim, 1);
subdivisions[0] = 2;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
std::vector<unsigned int> subdivisions (dim, 1);
subdivisions[0] = 2;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2015 by the deal.II authors
+// Copyright (C) 2000 - 2016 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
deallog << fe.get_name() << std::endl;
- Triangulation<dim> tr;
+ Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
std::vector<unsigned int> subdivisions (dim, 1);
subdivisions[0] = 2;