class.
- The deprecated constructor of MPI_InitFinalize
- The MPI support functions in namespace Utilities and Utilities::System.
-- Deprecated members of namespace types
+- Deprecated members of namespace types.
- Namespace deal_II_numbers.
+- Triangulation::distort_random.
<!-- ----------- GENERAL IMPROVEMENTS ----------------- -->
*/
void flip_all_direction_flags();
- /**
- * Distort the grid by randomly moving around all the vertices of the grid.
- * The direction of moving is random, while the length of the shift vector
- * has a value of @p factor times the minimal length of the active lines
- * adjacent to this vertex. Note that @p factor should obviously be well
- * below <tt>0.5</tt>.
- *
- * If @p keep_boundary is set to @p true (which is the default), then
- * boundary vertices are not moved.
- *
- * @deprecated Use GridTools::distort_random instead.
- */
- void distort_random (const double factor,
- const bool keep_boundary=true) DEAL_II_DEPRECATED;
-
/**
* @name Mesh refinement
* @{
}
- /**
- * Distort a triangulation in
- * some random way.
- */
- template <int dim, int spacedim>
- static
- void
- distort_random (const double factor,
- const bool keep_boundary,
- Triangulation<dim,spacedim> &triangulation)
- {
- GridTools::distort_random (factor, triangulation, keep_boundary);
- }
-
-
/**
* Actually delete a cell, or rather all
* its children, which is the main step for
-template <int dim, int spacedim>
-void Triangulation<dim, spacedim>::distort_random (const double factor,
- const bool keep_boundary)
-{
- internal::Triangulation::Implementation::distort_random (factor, keep_boundary, *this);
-}
-
-
-
template <int dim, int spacedim>
void Triangulation<dim, spacedim>::set_all_refine_flags ()
{
// ---------------------------------------------------------------------
//
-// Copyright (C) 2005 - 2013 by the deal.II authors
+// Copyright (C) 2005 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
#include <deal.II/grid/grid_generator.h>
#include <deal.II/grid/grid_out.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/fe/mapping_q.h>
#include <deal.II/fe/mapping_q1_eulerian.h>
// Then test same on distorted mesh
- tria_test.distort_random (0.05);
+ GridTools::distort_random (0.05, tria_test);
deallog << "Distorted mesh test" << std::endl;
evaluate_normal (dof_handler, solution);
}
// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2013 by the deal.II authors
+// Copyright (C) 2003 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
GridGenerator::hyper_rectangle (tria_test, p1, p2);
// tria_test.refine_global (1);
- // tria_test.distort_random (0.4);
+ // GridTools::distort_random (0.4, tria_test);
// Create a DoFHandler for the ABF space
FE_ABF<2> fe (0);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2013 by the deal.II authors
+// Copyright (C) 2003 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
#include <deal.II/fe/fe_raviart_thomas.h>
#include <deal.II/fe/fe_dgq.h>
#include <deal.II/fe/mapping_q1_eulerian.h>
+#include <deal.II/grid/grid_tools.h>
#include <fstream>
// Uncommenting the following line, demonstrates the problem
// of RT elements on distorted Quads!
- tria_test.distort_random (0.4);
+ GridTools::distort_random (0.4, tria_test);
// Create a DoFHandler for the RT space
FE_RaviartThomas<2> fe (2);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2013 by the deal.II authors
+// Copyright (C) 2003 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
#include <deal.II/fe/fe_raviart_thomas.h>
#include <deal.II/fe/fe_dgq.h>
#include <deal.II/fe/mapping_q1_eulerian.h>
+#include <deal.II/grid/grid_tools.h>
#include <fstream>
GridGenerator::hyper_rectangle (tria_test, p1, p2);
tria_test.refine_global (1);
- tria_test.distort_random (0.4);
+ GridTools::distort_random (0.4, tria_test);
// Create a DoFHandler for the RT space
FE_RaviartThomas<2> fe (2);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2013 by the deal.II authors
+// Copyright (C) 2003 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// tria_test.refine_global (1);
-// tria_test.distort_random (0.25);
+// GridTools::distort_random (0.25, tria_test);
FE_ABF<2> fe (0);
deallog << "Dofs/cell " << fe.dofs_per_cell
// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2013 by the deal.II authors
+// Copyright (C) 2003 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
GridGenerator::hyper_rectangle (tria_test, p1, p2);
// tria_test.refine_global (1);
- // tria_test.distort_random (0.4);
+ // GridTools::distort_random (0.4, tria_test);
// Create a DoFHandler for the RT space
FE_RaviartThomas<2> fe (1);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2013 by the deal.II authors
+// Copyright (C) 2003 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
#include <deal.II/grid/grid_generator.h>
#include <deal.II/grid/grid_out.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/fe/mapping_q.h>
#include <deal.II/fe/mapping_q1_eulerian.h>
GridGenerator::subdivided_hyper_rectangle (tria_test, sub_div, p1, p2);
tria_test.refine_global (2);
- tria_test.distort_random (0.05);
+ GridTools::distort_random (0.05, tria_test);
// Create a DoFHandler
FE_RaviartThomas<2> fe (1);