* (overwritten).
*
* In 1d, this function is not currently implemented.
+ *
+ * @deprecated This function has been moved to GridTools::laplace_transformation
*/
template <int dim>
- static void laplace_transformation (Triangulation<dim> &tria,
- const std::map<unsigned int,Point<dim> > &new_points);
+ static
+ void laplace_transformation (Triangulation<dim> &tria,
+ const std::map<unsigned int,Point<dim> > &new_points) DEAL_II_DEPRECATED;
/**
* Exception
void rotate (const double angle,
Triangulation<2> &triangulation);
+ /**
+ * This function transformes the @p Triangulation @p tria smoothly to a
+ * domain that is described by the boundary points in the map @p
+ * new_points. This map maps the point indices to the boundary points in the
+ * transformed domain.
+ *
+ * Note, that the @p Triangulation is changed in-place, therefore you don't
+ * need to keep two triangulations, but the given triangulation is changed
+ * (overwritten).
+ *
+ * In 1d, this function is not currently implemented.
+ */
+ template <int dim>
+ void laplace_transformation (const std::map<unsigned int,Point<dim> > &new_points,
+ Triangulation<dim> &tria);
+
/**
* Scale the entire triangulation
* by the given factor. To
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/grid/tria_boundary.h>
+#include <deal.II/grid/grid_generator.h>
#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/intergrid_map.h>
#include <deal.II/lac/sparsity_pattern.h>
}
+ template <int dim>
+ void
+ laplace_transformation (const std::map<unsigned int,Point<dim> > &new_points,
+ Triangulation<dim> &triangulation)
+ {
+ //TODO: Move implementation of this function into the current
+ // namespace
+ GridGenerator::laplace_transformation(triangulation, new_points);
+ }
+
+
+
template <int dim, int spacedim>
void
distort_random (const double factor,
const Triangulation<deal_II_dimension, deal_II_space_dimension> &triangulation_2,
Triangulation<deal_II_dimension, deal_II_space_dimension> &result);
#if deal_II_dimension == deal_II_space_dimension
+ template
+ void
+ laplace_transformation (const std::map<unsigned int,Point<deal_II_dimension> > &new_points,
+ Triangulation<deal_II_dimension> &triangulation);
+
template
Triangulation<deal_II_dimension,deal_II_space_dimension>::DistortedCellList
fix_up_distorted_child_cells