From: Marco Feder Date: Wed, 8 Jun 2022 08:12:25 +0000 (+0200) Subject: Surface deal.II tria to volumetric deal.II tria X-Git-Tag: v9.4.0-rc1~34^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=refs%2Fpull%2F13767%2Fhead;p=dealii.git Surface deal.II tria to volumetric deal.II tria --- diff --git a/include/deal.II/grid/grid_generator.h b/include/deal.II/grid/grid_generator.h index 054e28f5b7..a0f20e4c7a 100644 --- a/include/deal.II/grid/grid_generator.h +++ b/include/deal.II/grid/grid_generator.h @@ -1807,6 +1807,26 @@ namespace GridGenerator CGALWrappers::AdditionalData{}, const Point<3> &interior_point = Point<3>(), const double & outer_ball_radius = 1.0); + + /** + * Create a deal.II Triangulation<3> out of a deal.II Triangulation<2,3> + * by filling it with tetrahedra. + * + * The last optional argument @p data can be used to pass additional + * arguments to the CGAL::Mesh_criteria_3 class (see + * https://doc.cgal.org/latest/Mesh_3/index.html for more information). + * + * + * @param [in] surface_tria The input deal.II Triangulation<2,3>. + * @param [out] vol_tria The output deal.II Triangulation<3>. + * @param[in] data Additional parameters to pass to the CGAL::make_mesh_3 + * function. + */ + void + surface_mesh_to_volumetric_mesh(const Triangulation<2, 3> &surface_tria, + Triangulation<3> & vol_tria, + const CGALWrappers::AdditionalData<3> &data = + CGALWrappers::AdditionalData<3>{}); ///@} /** diff --git a/source/grid/grid_generator_cgal.cc b/source/grid/grid_generator_cgal.cc index ed9e7481ae..a5a7fafa69 100644 --- a/source/grid/grid_generator_cgal.cc +++ b/source/grid/grid_generator_cgal.cc @@ -143,6 +143,72 @@ namespace GridGenerator (void)outer_ball_radius; AssertThrow(false, ExcMessage("This function needs CGAL to be installed.")); +# endif + } + + + + void + surface_mesh_to_volumetric_mesh(const Triangulation<2, 3> &surface_tria, + Triangulation<3> & vol_tria, + const CGALWrappers::AdditionalData<3> &data) + { +# ifdef DEAL_II_WITH_CGAL + Assert( + surface_tria.n_cells() > 0, + ExcMessage( + "The input triangulation cannot be empty when calling this function.")); + Assert( + vol_tria.n_cells() == 0, + ExcMessage( + "The output triangulation must be empty when calling this function.")); + using K = CGAL::Exact_predicates_inexact_constructions_kernel; + using Point_3 = K::Point_3; + + using Mesh_domain = + CGAL::Polyhedral_mesh_domain_with_features_3>; + using Tr = CGAL::Mesh_triangulation_3::type; + using Mesh_criteria = CGAL::Mesh_criteria_3; + using C3t3 = + CGAL::Mesh_complex_3_in_triangulation_3; + + CGAL::Surface_mesh mesh; + // This function "fills" the missing arrow of the following diagram. + // Tria<2,3> Tria<3> + // | ^ + // | | + // | | + // | | + // V | + // CGAL::Surface_mesh -----------> CGAL::C3t3 + CGALWrappers::dealii_tria_to_cgal_surface_mesh(surface_tria, mesh); + CGAL::Polygon_mesh_processing::triangulate_faces(mesh); + CGAL::Polygon_mesh_processing::stitch_borders(mesh); + Mesh_domain domain(mesh); + domain.detect_features(); + Mesh_criteria criteria(CGAL::parameters::facet_size = data.facet_size, + CGAL::parameters::facet_angle = data.facet_angle, + CGAL::parameters::facet_distance = + data.facet_distance, + CGAL::parameters::cell_radius_edge_ratio = + data.cell_radius_edge_ratio, + CGAL::parameters::cell_size = data.cell_size); + const auto cgal_triangulation = CGAL::make_mesh_3(domain, criteria); + CGALWrappers::cgal_triangulation_to_dealii_triangulation(cgal_triangulation, + vol_tria); + +# else + + (void)surface_tria; + (void)vol_tria; + (void)data; + AssertThrow(false, ExcMessage("This function needs CGAL to be installed.")); + # endif } } // namespace GridGenerator diff --git a/tests/cgal/cgal_triangulation_07.cc b/tests/cgal/cgal_triangulation_07.cc new file mode 100644 index 0000000000..76f45e6a1f --- /dev/null +++ b/tests/cgal/cgal_triangulation_07.cc @@ -0,0 +1,52 @@ +// --------------------------------------------------------------------- +// +// Copyright (C) 2022 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. +// +// --------------------------------------------------------------------- + +// Create a Tria<3> out of a Tria<2,3>. + +#include + +#include +#include +#include +#include + +#include + +#include "../tests.h" + +using namespace CGALWrappers; +int +main() +{ + initlog(); + Triangulation<2, 3> surface_tria; + GridGenerator::hyper_sphere(surface_tria, {0., 1., 0.}, 1.); + surface_tria.refine_global(3); + + Triangulation<3> out_tria; + AdditionalData<3> data; + data.facet_size = 0.1; + data.facet_distance = 0.; + data.cell_radius_edge_ratio = 2.; + data.cell_size = 0.1; + GridGenerator::surface_mesh_to_volumetric_mesh(surface_tria, out_tria, data); + + GridOut go; + std::ofstream out_tria_name("tria_surface_to_volumetric.vtk"); + go.write_vtk(out_tria, out_tria_name); + + remove("tria_surface_to_volumetric.vtk"); + deallog << "OK" << std::endl; +} diff --git a/tests/cgal/cgal_triangulation_07.output b/tests/cgal/cgal_triangulation_07.output new file mode 100644 index 0000000000..0fd8fc12f0 --- /dev/null +++ b/tests/cgal/cgal_triangulation_07.output @@ -0,0 +1,2 @@ + +DEAL::OK