- The version of parallel::distributed::Vector::scale
function that takes a scalar as argument.
- GridTools::create_union_triangulation.
+ - GridTools::extract_boundary_mesh.
<br>
This release also removes the deprecated class MGDoFHandler. The
functionality of this class had previously been incorporated into
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_boundary_lib.h>
#include <deal.II/grid/grid_generator.h>
-#include <deal.II/grid/grid_tools.h>
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/vector.h>
#include <deal.II/lac/solver_control.h>
// indicators of all faces on the outside of the boundary to zero for the
// ones located on the perimeter of the disk/ball, and one on the straight
// part that splits the full disk/ball into two halves. The next step is the
- // main point: The GridTools::extract_boundary_mesh function creates a mesh
+ // main point: The GridGenerator::extract_boundary_mesh function creates a mesh
// that consists of those cells that are the faces of the previous mesh,
// i.e. it describes the <i>surface</i> cells of the original (volume)
// mesh. However, we do not want all faces: only those on the perimeter of
// the disk or ball which carry boundary indicator zero; we can select these
// cells using a set of boundary indicators that we pass to
- // GridTools::extract_boundary_mesh.
+ // GridGenerator::extract_boundary_mesh.
//
// There is one point that needs to be mentioned. In order to refine a
// surface mesh appropriately if the manifold is curved (similarly to
std::set<types::boundary_id> boundary_ids;
boundary_ids.insert (0);
- GridTools::extract_boundary_mesh (volume_mesh, triangulation,
- boundary_ids);
+ GridGenerator::extract_boundary_mesh (volume_mesh, triangulation,
+ boundary_ids);
}
triangulation.refine_global(4);
};
#endif
- /**
- * @deprecated Use GridGenerator::extract_boundary_mesh() instead.
- */
- template <template <int,int> class Container, int dim, int spacedim>
-#ifndef _MSC_VER
- std::map<typename Container<dim-1,spacedim>::cell_iterator,
- typename Container<dim,spacedim>::face_iterator>
-#else
- typename ExtractBoundaryMesh<Container,dim,spacedim>::return_type
-#endif
- extract_boundary_mesh (const Container<dim,spacedim> &volume_mesh,
- Container<dim-1,spacedim> &surface_mesh,
- const std::set<types::boundary_id> &boundary_ids
- = std::set<types::boundary_id>()) DEAL_II_DEPRECATED;
-
/*@}*/
/**
* @name Dealing with periodic domains
- template <template <int,int> class Container, int dim, int spacedim>
-#ifndef _MSC_VER
- std::map<typename Container<dim-1,spacedim>::cell_iterator,
- typename Container<dim,spacedim>::face_iterator>
-#else
- typename ExtractBoundaryMesh<Container,dim,spacedim>::return_type
-#endif
- extract_boundary_mesh (const Container<dim,spacedim> &volume_mesh,
- Container<dim-1,spacedim> &surface_mesh,
- const std::set<types::boundary_id> &boundary_ids)
- {
- // this function is deprecated. call the one that replaced it
- return GridGenerator::extract_boundary_mesh (volume_mesh, surface_mesh, boundary_ids);
- }
-
-
-
/*
* Internally used in orthogonal_equality
*
std::vector<Container<deal_II_dimension,deal_II_space_dimension>::active_cell_iterator>
get_patch_around_cell<Container<deal_II_dimension,deal_II_space_dimension> >
(const Container<deal_II_dimension,deal_II_space_dimension>::active_cell_iterator &cell);
-
-
-#if deal_II_dimension != 1
- template
-#ifndef _MSC_VER
- std::map<Container<deal_II_dimension-1,deal_II_space_dimension>::cell_iterator,
- Container<deal_II_dimension,deal_II_space_dimension>::face_iterator>
-#else
- ExtractBoundaryMesh<Container,deal_II_dimension,deal_II_space_dimension>::return_type
-#endif
- extract_boundary_mesh (const Container<deal_II_dimension, deal_II_space_dimension> &mesh,
- Container<deal_II_dimension-1,deal_II_space_dimension> &boundary_mesh,
- const std::set<types::boundary_id> &boundary_ids);
-#endif
- \}
+ \}
#endif
-
}