--- /dev/null
+Removed: The deprecated functions GridReordering::reorder_cells()
+and GridReordering::invert_all_cells_of_negative_grid()
+have been removed.
+<br>
+(Daniel Arndt, 2023/07/03)
* Before a list of cells is passed to an object of the Triangulation class
* for creation of a triangulation, you therefore have to make sure that cells
* are oriented in a compatible fashion, so that edge directions are globally
- * according to above convention. However, the GridReordering class can do
- * this for you, by reorienting cells and edges of an arbitrary list of input
- * cells that need not be already sorted.
+ * according to above convention. However, the
+ * GridTools::consistently_order_cells() function can do this for you, by
+ * reorienting cells and edges of an arbitrary list of input cells that need not
+ * be already sorted.
*
* <h4>Faces</h4>
*
* have orientations that need to be taken care of.
*
* For this reason, the <tt>read_*</tt> functions of this class that read in
- * grids in various input formats call the GridReordering class to bring the
- * order of vertices that define the cells into an ordering that satisfies the
- * requirements of the Triangulation class. Be sure to read the documentation
- * of that class if you experience unexpected problems when reading grids
- * through this class.
+ * grids in various input formats call the GridTools::consistently_order_cells()
+ * function to bring the order of vertices that define the cells into an
+ * ordering that satisfies the requirements of the Triangulation class. Be sure
+ * to read the documentation of that class if you experience unexpected problems
+ * when reading grids through this class.
*
*
* <h3>Dealing with distorted mesh cells</h3>
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2000 - 2023 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE.md at
-// the top level directory of deal.II.
-//
-// ---------------------------------------------------------------------
-
-#ifndef dealii_grid_reordering_h
-#define dealii_grid_reordering_h
-
-
-#include <deal.II/base/config.h>
-
-#include <deal.II/grid/tria.h>
-
-#include <vector>
-
-DEAL_II_NAMESPACE_OPEN
-
-/**
- * A class implementing various grid reordering algorithms. For more information
- * see the
- * @ref reordering "reordering module".
- *
- * @deprecated Use GridTools::invert_all_negative_measure_cells() or
- * GridTools::consistently_order_cells() instead of the functions provided by
- * this class. Usage of the old-style numbering is deprecated.
- */
-template <int dim, int spacedim = dim>
-class GridReordering
-{
-public:
- /**
- * This is the main function, doing what is announced in the general
- * documentation of this class for dim=2 and 3 and doing nothing for dim=1.
- *
- * If a consistent reordering is not possible in dim=3, the original
- * connectivity data is restored.
- *
- * @param original_cells An object that contains the data that describes the
- * mesh.
- * @param use_new_style_ordering If true, then use the standard ordering of
- * vertices within a cell. If false (the default), then use the "old-style"
- * ordering of vertices within cells used by deal.II before version 5.2 and
- * as explained in the documentation of this class.
- *
- * @deprecated Use GridTools::consistently_order_cells() instead.
- */
- DEAL_II_DEPRECATED
- static void
- reorder_cells(std::vector<CellData<dim>> &original_cells,
- const bool use_new_style_ordering = false);
-
- /**
- * Grids generated by grid generators may have an orientation of cells which
- * is the inverse of the orientation required by deal.II.
- *
- * In 2d and 3d this function checks whether all cells have negative or
- * positive measure/volume. In the former case, all cells are inverted. It
- * does nothing in 1d.
- *
- * The inversion of cells might also work when only a subset of all cells
- * have negative volume. However, grids consisting of a mixture of negative
- * and positively oriented cells are very likely to be broken. Therefore, an
- * exception is thrown, in case cells are not uniformly oriented.
- *
- * Note, that this function should be called before reorder_cells().
- *
- * @param all_vertices The vertices of the mesh.
- * @param original_cells An object that contains the data that describes the
- * mesh.
- * @param use_new_style_ordering If true, then use the standard ordering of
- * vertices within a cell. If false (the default), then use the "old-style"
- * ordering of vertices within cells used by deal.II before version 5.2 and
- * as explained in the documentation of this class.
- *
- * @deprecated Use GridTools::invert_all_negative_measure_cells() instead.
- */
- DEAL_II_DEPRECATED
- static void
- invert_all_cells_of_negative_grid(
- const std::vector<Point<spacedim>> &all_vertices,
- std::vector<CellData<dim>> & original_cells,
- const bool use_new_style_ordering = false);
-};
-
-
-// declaration of explicit specializations
-template <>
-void
-GridReordering<2>::invert_all_cells_of_negative_grid(
- const std::vector<Point<2>> &all_vertices,
- std::vector<CellData<2>> & cells,
- const bool use_new_style_ordering);
-
-template <>
-void
-GridReordering<2, 3>::invert_all_cells_of_negative_grid(
- const std::vector<Point<3>> &all_vertices,
- std::vector<CellData<2>> & cells,
- const bool use_new_style_ordering);
-
-template <>
-void
-GridReordering<3>::invert_all_cells_of_negative_grid(
- const std::vector<Point<3>> &all_vertices,
- std::vector<CellData<3>> & cells,
- const bool use_new_style_ordering);
-
-DEAL_II_NAMESPACE_CLOSE
-
-#endif
<< "The given vertex with index " << arg1
<< " is not used in the given triangulation.");
+ /**
+ * An exception that is thrown whenever the edges of a mesh are not
+ * orientable.
+ *
+ * @ingroup Exceptions
+ */
+ DeclExceptionMsg(ExcMeshNotOrientable,
+ "The edges of the mesh are not consistently orientable.");
+
/** @} */
} /*namespace GridTools*/
-/**
- * An exception that is thrown whenever the edges of a mesh are not
- * orientable.
- *
- * @note for backwards compatibility with the old GridReordering class this
- * exception is not in the GridTools namespace.
- *
- * @ingroup Exceptions
- */
-DeclExceptionMsg(ExcMeshNotOrientable,
- "The edges of the mesh are not consistently orientable.");
-
-
/* ----------------- Template function --------------- */
* numbering within cells. They do not only hold for the data read from an UCD
* or any other input file, but also for the data passed to
* create_triangulation(). See the documentation for the GridIn class for more
- * details on this, and above all to the GridReordering class that explains
- * many of the problems and an algorithm to reorder cells such that they
- * satisfy the conditions outlined above.
+ * details on this, and above all to the GridTools::consistently_order_cells()
+ * function that explains many of the problems and an algorithm to reorder cells
+ * such that they satisfy the conditions outlined above.
*
* <li> Copying a triangulation: when computing on time dependent meshes or
* when using adaptive refinement, you will often want to create a new
* constraints; see the general class documentation for this.
*
* For conditions when this function can generate a valid triangulation, see
- * the documentation of this class, and the GridIn and GridReordering class.
+ * the documentation of this class, and the GridIn and
+ * GridTools::consistently_order_cells() function.
*
* If the <code>check_for_distorted_cells</code> flag was specified upon
* creation of this object, at the very end of its operation, the current
set(_unity_include_src
cell_id.cc
grid_refinement.cc
- grid_reordering.cc
intergrid_map.cc
manifold.cc
manifold_lib.cc
#include <deal.II/grid/filtered_iterator.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/intergrid_map.h>
#include <deal.II/grid/manifold_lib.h>
#include <deal.II/base/utilities.h>
#include <deal.II/grid/grid_in.h>
-#include <deal.II/grid/grid_reordering.h>
#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2000 - 2023 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE.md at
-// the top level directory of deal.II.
-//
-// ---------------------------------------------------------------------
-
-
-#include <deal.II/base/timer.h>
-#include <deal.II/base/utilities.h>
-
-#include <deal.II/grid/grid_reordering.h>
-#include <deal.II/grid/grid_tools.h>
-
-#include <algorithm>
-#include <fstream>
-#include <functional>
-#include <iostream>
-
-DEAL_II_NAMESPACE_OPEN
-
-
-// anonymous namespace for internal helper functions
-namespace
-{
- /**
- * This file uses a different ordering for the vertices in a hex
- * cell than we usually do in deal.II. The different convention used
- * here originates in what we believed the ordering to be in UCD
- * format, until it was discovered in 2022 that UCD will interpret
- * this ordering to correspond to inverted cells -- as a
- * consequence, the UCD ordering was fixed, but the current file is
- * stuck on the old ordering.
- */
- constexpr std::array<unsigned int, 8> local_vertex_numbering{
- {0, 1, 5, 4, 2, 3, 7, 6}};
-
- /**
- * Following is a set of functions that reorder the data from the
- * "current" to the "classic" format of vertex numbering of cells
- * and faces. These functions do the reordering of their arguments
- * in-place.
- */
- void
- reorder_new_to_old_style(std::vector<CellData<1>> &)
- {}
-
-
- void
- reorder_new_to_old_style(std::vector<CellData<2>> &cells)
- {
- for (auto &cell : cells)
- std::swap(cell.vertices[2], cell.vertices[3]);
- }
-
-
- void
- reorder_new_to_old_style(std::vector<CellData<3>> &cells)
- {
- unsigned int tmp[GeometryInfo<3>::vertices_per_cell];
- for (auto &cell : cells)
- {
- for (const unsigned int i : GeometryInfo<3>::vertex_indices())
- tmp[i] = cell.vertices[i];
- for (const unsigned int i : GeometryInfo<3>::vertex_indices())
- cell.vertices[i] = tmp[local_vertex_numbering[i]];
- }
- }
-
-
- /**
- * And now also in the opposite direction.
- */
- void
- reorder_old_to_new_style(std::vector<CellData<1>> &)
- {}
-
-
- void
- reorder_old_to_new_style(std::vector<CellData<2>> &cells)
- {
- // just invert the permutation:
- reorder_new_to_old_style(cells);
- }
-
-
- void
- reorder_old_to_new_style(std::vector<CellData<3>> &cells)
- {
- // undo the ordering above
- unsigned int tmp[GeometryInfo<3>::vertices_per_cell];
- for (auto &cell : cells)
- {
- for (const unsigned int i : GeometryInfo<3>::vertex_indices())
- tmp[i] = cell.vertices[i];
- for (const unsigned int i : GeometryInfo<3>::vertex_indices())
- cell.vertices[local_vertex_numbering[i]] = tmp[i];
- }
- }
-} // namespace
-
-
-
-template <int dim, int spacedim>
-void
-GridReordering<dim, spacedim>::reorder_cells(std::vector<CellData<dim>> &cells,
- const bool use_new_style_ordering)
-{
- Assert(cells.size() != 0,
- ExcMessage("List of elements to orient must have at least one cell"));
-
- // there is nothing for us to do in 1d
- if (dim == 1)
- return;
-
- // if necessary, convert to new-style format
- if (use_new_style_ordering == false)
- reorder_old_to_new_style(cells);
-
- GridTools::consistently_order_cells(cells);
-
- // and convert back if necessary
- if (use_new_style_ordering == false)
- reorder_new_to_old_style(cells);
-}
-
-
-
-template <>
-void
-GridReordering<1>::invert_all_cells_of_negative_grid(
- const std::vector<Point<1>> &,
- std::vector<CellData<1>> &,
- const bool)
-{
- // nothing to be done in 1d
-}
-
-
-
-template <>
-void
-GridReordering<1, 2>::invert_all_cells_of_negative_grid(
- const std::vector<Point<2>> &,
- std::vector<CellData<1>> &,
- const bool)
-{
- // nothing to be done in 1d
-}
-
-
-
-template <>
-void
-GridReordering<1, 3>::invert_all_cells_of_negative_grid(
- const std::vector<Point<3>> &,
- std::vector<CellData<1>> &,
- const bool)
-{
- // nothing to be done in 1d
-}
-
-
-template <>
-void
-GridReordering<2>::invert_all_cells_of_negative_grid(
- const std::vector<Point<2>> &all_vertices,
- std::vector<CellData<2>> & cells,
- const bool use_new_style_ordering)
-{
- if (!use_new_style_ordering)
- reorder_old_to_new_style(cells);
-
- GridTools::invert_all_negative_measure_cells(all_vertices, cells);
-
- if (!use_new_style_ordering)
- reorder_new_to_old_style(cells);
-}
-
-
-
-template <>
-void
-GridReordering<2, 3>::invert_all_cells_of_negative_grid(
- const std::vector<Point<3>> &,
- std::vector<CellData<2>> &,
- const bool)
-{
- Assert(false, ExcNotImplemented());
-}
-
-
-
-template <>
-void
-GridReordering<3>::invert_all_cells_of_negative_grid(
- const std::vector<Point<3>> &all_vertices,
- std::vector<CellData<3>> & cells,
- const bool use_new_style_ordering)
-{
- if (!use_new_style_ordering)
- reorder_old_to_new_style(cells);
-
- GridTools::invert_all_negative_measure_cells(all_vertices, cells);
-
- if (!use_new_style_ordering)
- reorder_new_to_old_style(cells);
-}
-
-
-
-/* ------------------------ explicit instantiations ------------------- */
-template class GridReordering<1, 1>;
-template class GridReordering<1, 2>;
-template class GridReordering<1, 3>;
-template class GridReordering<2, 2>;
-template class GridReordering<2, 3>;
-template class GridReordering<3, 3>;
-
-DEAL_II_NAMESPACE_CLOSE
#include <deal.II/fe/mapping_q.h>
#include <deal.II/grid/filtered_iterator.h>
-#include <deal.II/grid/grid_reordering.h>
#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/grid_tools_cache.h>
#include <deal.II/grid/manifold.h>
#include <deal.II/fe/mapping_q.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
// functions
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
// similar to the hyper_ball_3d test, but for the cylinder grid. here,
// the cause for the failure was different, though: the description of
// the cells was wrong, and they were not sent through the
-// GridReordering class which would have cured the problem.
+// GridTools::consistently_order_cells() function which would have cured the
+// problem.
#include <deal.II/grid/grid_generator.h>
#include <deal.II/fe/fe_values.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/fe/fe_values.h>
#include <deal.II/grid/grid_in.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/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 <deal.II/grid/grid_reordering.h>
#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/manifold.h>
#include <deal.II/grid/tria.h>
#include <deal.II/fe/fe_values.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/base/geometry_info.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
// generate a triangulation
// out of this
- GridReordering<2>::reorder_cells(cells);
+ GridTools::consistently_order_cells(cells);
try
{
tria.create_triangulation_compatibility(vertices, cells, SubCellData());
#include <deal.II/fe/fe_values.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
// finally generate a triangulation
// out of this
- GridReordering<3>::reorder_cells(cells);
+ GridTools::consistently_order_cells(cells);
coarse_grid.create_triangulation_compatibility(vertices,
cells,
SubCellData());
#include <deal.II/fe/mapping_q_eulerian.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
-// Test GridReordering<3>::reorder_cells
+// Test GridTools::consistently_order_cells
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
cells[i].material_id = 0;
};
- GridReordering<3>::reorder_cells(cells);
+ GridTools::consistently_order_cells(cells);
tria.create_triangulation(std::vector<Point<3>>(&vertices[0], &vertices[16]),
cells,
SubCellData()); // no boundary information
-// Test GridReordering<3>::reorder_cells
+// Test GridTools::consistently_order_cells
#include <deal.II/grid/grid_generator.h>
#include <deal.II/grid/grid_out.h>
#include <deal.II/dofs/dof_handler.h>
#include <deal.II/grid/grid_out.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <string>
#include "../tests.h"
+namespace
+{
+ /**
+ * This file uses a different ordering for the vertices in a hex
+ * cell than we usually do in deal.II. The different convention used
+ * here originates in what we believed the ordering to be in UCD
+ * format, until it was discovered in 2022 that UCD will interpret
+ * this ordering to correspond to inverted cells -- as a
+ * consequence, the UCD ordering was fixed, but the current file is
+ * stuck on the old ordering.
+ */
+ constexpr std::array<unsigned int, 8> local_vertex_numbering{
+ {0, 1, 5, 4, 2, 3, 7, 6}};
+
+ /**
+ * Following is a set of functions that reorder the data from the
+ * "current" to the "classic" format of vertex numbering of cells
+ * and faces. These functions do the reordering of their arguments
+ * in-place.
+ */
+ void
+ reorder_old_to_new_style(std::vector<CellData<2>> &cells)
+ {
+ for (auto &cell : cells)
+ std::swap(cell.vertices[2], cell.vertices[3]);
+ }
+
+
+ void
+ reorder_old_to_new_style(std::vector<CellData<3>> &cells)
+ {
+ // undo the ordering above
+ unsigned int tmp[GeometryInfo<3>::vertices_per_cell];
+ for (auto &cell : cells)
+ {
+ for (const unsigned int i : GeometryInfo<3>::vertex_indices())
+ tmp[i] = cell.vertices[i];
+ for (const unsigned int i : GeometryInfo<3>::vertex_indices())
+ cell.vertices[local_vertex_numbering[i]] = tmp[i];
+ }
+ }
+} // namespace
+
template <int dim>
void
test(bool second_case = false)
}
SubCellData subcelldata;
- GridReordering<dim>::invert_all_cells_of_negative_grid(vertices, cells);
+
+ reorder_old_to_new_style(cells);
+ GridTools::invert_all_negative_measure_cells(vertices, cells);
Triangulation<dim> tria;
- tria.create_triangulation_compatibility(vertices, cells, subcelldata);
+ tria.create_triangulation(vertices, cells, subcelldata);
std::ostream &logfile = deallog.get_file_stream();
logfile << "---------------------------------------------" << std::endl
//
// ---------------------------------------------------------------------
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
// match up for the standard orientation of the normals. we thus have
// to store the face orientation in each cell
+namespace
+{
+ /**
+ * This file uses a different ordering for the vertices in a hex
+ * cell than we usually do in deal.II. The different convention used
+ * here originates in what we believed the ordering to be in UCD
+ * format, until it was discovered in 2022 that UCD will interpret
+ * this ordering to correspond to inverted cells -- as a
+ * consequence, the UCD ordering was fixed, but the current file is
+ * stuck on the old ordering.
+ */
+ constexpr std::array<unsigned int, 8> local_vertex_numbering{
+ {0, 1, 5, 4, 2, 3, 7, 6}};
+
+ /**
+ * And now also in the opposite direction.
+ */
+ void
+ reorder_old_to_new_style(std::vector<CellData<3>> &cells)
+ {
+ // undo the ordering above
+ unsigned int tmp[GeometryInfo<3>::vertices_per_cell];
+ for (auto &cell : cells)
+ {
+ for (const unsigned int i : GeometryInfo<3>::vertex_indices())
+ tmp[i] = cell.vertices[i];
+ for (const unsigned int i : GeometryInfo<3>::vertex_indices())
+ cell.vertices[local_vertex_numbering[i]] = tmp[i];
+ }
+ }
+} // namespace
+
void
create_two_cubes(Triangulation<3> &coarse_grid)
{
// finally generate a triangulation
// out of this
- GridReordering<3>::reorder_cells(cells);
- coarse_grid.create_triangulation_compatibility(vertices,
- cells,
- SubCellData());
+ // if necessary, convert to new-style format
+ reorder_old_to_new_style(cells);
+ GridTools::consistently_order_cells(cells);
+ coarse_grid.create_triangulation(vertices, cells, SubCellData());
}
// finally generate a triangulation
// out of this
- GridReordering<3>::reorder_cells(cells);
- coarse_grid.create_triangulation_compatibility(vertices,
- cells,
- SubCellData());
+ reorder_old_to_new_style(cells);
+ GridTools::consistently_order_cells(cells);
+ coarse_grid.create_triangulation(vertices, cells, SubCellData());
}
// coarsening_3d), but we can check this fact much earlier already (done
// here)
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/fe/fe_values.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/fe/fe_values.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/fe/fe_q.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/base/quadrature_lib.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/fe/fe_values.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/fe/fe_q.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/fe/fe_values.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/grid/grid_in.h>
#include <deal.II/grid/grid_out.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
// this test just checks that such a mesh can be created. further
// tests check that we are still producing consistent states with this
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/fe/fe_values.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/fe/fe_values.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
//
// for this grid, check that vertex numbers still match up
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
// counting them
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
// looking at them and checking their children
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/fe/fe_values.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/fe/fe_values.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/fe/fe_values.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/fe/fe_values.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
+#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
// This test verifies that the transfinite interpolation works on a cylinder
// with oblique faces
-#include <deal.II/grid/grid_reordering.h>
#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/manifold_lib.h>
#include <deal.II/grid/tria.h>
// This test verifies that the transfinite interpolation works on a distorted
// cylinder with some given coordinates
-#include <deal.II/grid/grid_reordering.h>
#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/manifold_lib.h>
#include <deal.II/grid/tria.h>
#include <deal.II/fe/mapping_q1_eulerian.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/fe/mapping_q_eulerian.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/fe/mapping_q_eulerian.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/fe/mapping_q_eulerian.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/fe/mapping_q_eulerian.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/fe/mapping_q_eulerian.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/fe/mapping_q_eulerian.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_reordering.h>
#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/grid_generator.h>
#include <deal.II/grid/grid_out.h>
-#include <deal.II/grid/grid_reordering.h>
#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>