Reference documentation for deal.II version 9.0.0
Public Member Functions | Static Public Member Functions | Protected Attributes | Private Member Functions | List of all members
HyperBallBoundary< dim, spacedim > Class Template Reference

#include <deal.II/grid/tria_boundary_lib.h>

Inheritance diagram for HyperBallBoundary< dim, spacedim >:
[legend]

Public Member Functions

 HyperBallBoundary (const Point< spacedim > p=Point< spacedim >(), const double radius=1.0)
 
virtual std::unique_ptr< Manifold< dim, spacedim > > clone () const override
 
virtual Point< spacedim > get_new_point_on_line (const typename Triangulation< dim, spacedim >::line_iterator &line) const override
 
virtual Point< spacedim > get_new_point_on_quad (const typename Triangulation< dim, spacedim >::quad_iterator &quad) const override
 
virtual void get_intermediate_points_on_line (const typename Triangulation< dim, spacedim >::line_iterator &line, std::vector< Point< spacedim > > &points) const override
 
virtual void get_intermediate_points_on_quad (const typename Triangulation< dim, spacedim >::quad_iterator &quad, std::vector< Point< spacedim > > &points) const override
 
virtual Tensor< 1, spacedim > normal_vector (const typename Triangulation< dim, spacedim >::face_iterator &face, const Point< spacedim > &p) const override
 
virtual void get_normals_at_vertices (const typename Triangulation< dim, spacedim >::face_iterator &face, typename Boundary< dim, spacedim >::FaceVertexNormals &face_vertex_normals) const override
 
Point< spacedim > get_center () const
 
double get_radius () const
 
- Public Member Functions inherited from StraightBoundary< dim, spacedim >
 StraightBoundary ()
 
virtual Point< spacedim > project_to_surface (const typename Triangulation< dim, spacedim >::line_iterator &line, const Point< spacedim > &candidate) const override
 
virtual Point< spacedim > project_to_surface (const typename Triangulation< dim, spacedim >::quad_iterator &quad, const Point< spacedim > &candidate) const override
 
virtual Point< spacedim > project_to_surface (const typename Triangulation< dim, spacedim >::hex_iterator &hex, const Point< spacedim > &candidate) const override
 
- Public Member Functions inherited from Boundary< dim, spacedim >
virtual ~Boundary () override=default
 
void get_intermediate_points_on_face (const typename Triangulation< dim, spacedim >::face_iterator &face, std::vector< Point< spacedim > > &points) const
 
- Public Member Functions inherited from FlatManifold< dim, spacedim >
 FlatManifold (const Tensor< 1, spacedim > &periodicity=Tensor< 1, spacedim >(), const double tolerance=1e-10)
 
virtual Point< spacedim > get_new_point (const ArrayView< const Point< spacedim >> &surrounding_points, const ArrayView< const double > &weights) const override
 
virtual void get_new_points (const ArrayView< const Point< spacedim >> &surrounding_points, const Table< 2, double > &weights, ArrayView< Point< spacedim >> new_points) const override
 
virtual Point< spacedim > project_to_manifold (const ArrayView< const Point< spacedim >> &points, const Point< spacedim > &candidate) const override
 
virtual Tensor< 1, spacedim > get_tangent_vector (const Point< spacedim > &x1, const Point< spacedim > &x2) const override
 
virtual void get_normals_at_vertices (const typename Triangulation< dim, spacedim >::face_iterator &face, typename Manifold< dim, spacedim >::FaceVertexNormals &face_vertex_normals) const override
 
const Tensor< 1, spacedim > & get_periodicity () const
 
- Public Member Functions inherited from Manifold< dim, spacedim >
virtual ~Manifold ()=default
 
virtual Point< spacedim > get_intermediate_point (const Point< spacedim > &p1, const Point< spacedim > &p2, const double w) const
 
virtual Point< spacedim > get_new_point_on_hex (const typename Triangulation< dim, spacedim >::hex_iterator &hex) const
 
Point< spacedim > get_new_point_on_face (const typename Triangulation< dim, spacedim >::face_iterator &face) const
 
Point< spacedim > get_new_point_on_cell (const typename Triangulation< dim, spacedim >::cell_iterator &cell) const
 
virtual void get_normals_at_vertices (const typename Triangulation< dim, spacedim >::face_iterator &face, FaceVertexNormals &face_vertex_normals) const
 
- Public Member Functions inherited from Subscriptor
 Subscriptor ()
 
 Subscriptor (const Subscriptor &)
 
 Subscriptor (Subscriptor &&) noexcept
 
virtual ~Subscriptor ()
 
Subscriptoroperator= (const Subscriptor &)
 
Subscriptoroperator= (Subscriptor &&) noexcept
 
void subscribe (const char *identifier=nullptr) const
 
void unsubscribe (const char *identifier=nullptr) const
 
unsigned int n_subscriptions () const
 
void list_subscribers () const
 
template<class Archive >
void serialize (Archive &ar, const unsigned int version)
 

Static Public Member Functions

static ::ExceptionBaseExcRadiusNotSet ()
 
- Static Public Member Functions inherited from Subscriptor
static ::ExceptionBaseExcInUse (int arg1, std::string arg2, std::string arg3)
 
static ::ExceptionBaseExcNoSubscriber (std::string arg1, std::string arg2)
 

Protected Attributes

const Point< spacedim > center
 
const double radius
 
bool compute_radius_automatically
 

Private Member Functions

void get_intermediate_points_between_points (const Point< spacedim > &p0, const Point< spacedim > &p1, std::vector< Point< spacedim > > &points) const
 

Additional Inherited Members

- Public Types inherited from Manifold< dim, spacedim >
typedef Tensor< 1, spacedim > FaceVertexNormals[GeometryInfo< dim >::vertices_per_face]
 
- Protected Member Functions inherited from Boundary< dim, spacedim >
const std::vector< Point< 1 > > & get_line_support_points (const unsigned int n_intermediate_points) const
 

Detailed Description

template<int dim, int spacedim = dim>
class HyperBallBoundary< dim, spacedim >

Specialization of Boundary<dim>, which places the new point on the boundary of a ball in arbitrary dimension. It works by projecting the point in the middle of the old points onto the ball. The middle is defined as the arithmetic mean of the points.

The center of the ball and its radius may be given upon construction of an object of this type. They default to the origin and a radius of 1.0.

This class is derived from StraightBoundary rather than from Boundary, which would seem natural, since this way we can use the StraightBoundary::in_between() function.

Deprecated:
The boundary classes have been deprecated in favor of the more general Manifold classes. For this class SphericalManifold is an appropriate replacement which is expected to produce better results under mesh refinement.
Author
Wolfgang Bangerth, 1998, Ralf Hartmann, 2001

Definition at line 355 of file tria_boundary_lib.h.

Constructor & Destructor Documentation

◆ HyperBallBoundary()

template<int dim, int spacedim>
HyperBallBoundary< dim, spacedim >::HyperBallBoundary ( const Point< spacedim >  p = Point<spacedim>(),
const double  radius = 1.0 
)

Constructor

Definition at line 527 of file tria_boundary_lib.cc.

Member Function Documentation

◆ clone()

template<int dim, int spacedim>
std::unique_ptr< Manifold< dim, spacedim > > HyperBallBoundary< dim, spacedim >::clone ( ) const
overridevirtual

Clone this Boundary object.

Reimplemented from StraightBoundary< dim, spacedim >.

Reimplemented in HalfHyperShellBoundary< dim >, HyperShellBoundary< dim >, and HalfHyperBallBoundary< dim >.

Definition at line 539 of file tria_boundary_lib.cc.

◆ get_new_point_on_line()

template<int dim, int spacedim>
Point< spacedim > HyperBallBoundary< dim, spacedim >::get_new_point_on_line ( const typename Triangulation< dim, spacedim >::line_iterator &  line) const
overridevirtual

Refer to the general documentation of this class and the documentation of the base class.

Reimplemented from StraightBoundary< dim, spacedim >.

Definition at line 548 of file tria_boundary_lib.cc.

◆ get_new_point_on_quad()

template<int dim, int spacedim>
Point< spacedim > HyperBallBoundary< dim, spacedim >::get_new_point_on_quad ( const typename Triangulation< dim, spacedim >::quad_iterator &  quad) const
overridevirtual

Refer to the general documentation of this class and the documentation of the base class.

Reimplemented from StraightBoundary< dim, spacedim >.

Definition at line 592 of file tria_boundary_lib.cc.

◆ get_intermediate_points_on_line()

template<int dim, int spacedim>
void HyperBallBoundary< dim, spacedim >::get_intermediate_points_on_line ( const typename Triangulation< dim, spacedim >::line_iterator &  line,
std::vector< Point< spacedim > > &  points 
) const
overridevirtual

Refer to the general documentation of this class and the documentation of the base class.

Calls get_intermediate_points_between_points.

Reimplemented from StraightBoundary< dim, spacedim >.

Definition at line 626 of file tria_boundary_lib.cc.

◆ get_intermediate_points_on_quad()

template<int dim, int spacedim>
void HyperBallBoundary< dim, spacedim >::get_intermediate_points_on_quad ( const typename Triangulation< dim, spacedim >::quad_iterator &  quad,
std::vector< Point< spacedim > > &  points 
) const
overridevirtual

Refer to the general documentation of this class and the documentation of the base class.

Only implemented for dim=3 and for points.size()==1.

Reimplemented from StraightBoundary< dim, spacedim >.

Definition at line 769 of file tria_boundary_lib.cc.

◆ normal_vector()

template<int dim, int spacedim>
Tensor< 1, spacedim > HyperBallBoundary< dim, spacedim >::normal_vector ( const typename Triangulation< dim, spacedim >::face_iterator &  face,
const Point< spacedim > &  p 
) const
overridevirtual

Implementation of the function declared in the base class.

Refer to the general documentation of this class and the documentation of the base class.

Reimplemented from StraightBoundary< dim, spacedim >.

Definition at line 781 of file tria_boundary_lib.cc.

◆ get_normals_at_vertices()

template<int dim, int spacedim>
void HyperBallBoundary< dim, spacedim >::get_normals_at_vertices ( const typename Triangulation< dim, spacedim >::face_iterator &  face,
typename Boundary< dim, spacedim >::FaceVertexNormals face_vertex_normals 
) const
overridevirtual

Compute the normals to the boundary at the vertices of the given face.

Refer to the general documentation of this class and the documentation of the base class.

Reimplemented from StraightBoundary< dim, spacedim >.

Definition at line 813 of file tria_boundary_lib.cc.

◆ get_center()

template<int dim, int spacedim>
Point< spacedim > HyperBallBoundary< dim, spacedim >::get_center ( ) const

Return the center of the ball.

Definition at line 824 of file tria_boundary_lib.cc.

◆ get_radius()

template<int dim, int spacedim>
double HyperBallBoundary< dim, spacedim >::get_radius ( ) const

Return the radius of the ball.

Definition at line 833 of file tria_boundary_lib.cc.

◆ get_intermediate_points_between_points()

template<int dim, int spacedim>
void HyperBallBoundary< dim, spacedim >::get_intermediate_points_between_points ( const Point< spacedim > &  p0,
const Point< spacedim > &  p1,
std::vector< Point< spacedim > > &  points 
) const
private

Called by get_intermediate_points_on_line and by get_intermediate_points_on_quad.

Refer to the general documentation of get_intermediate_points_on_line in the documentation of the base class.

Definition at line 640 of file tria_boundary_lib.cc.

Member Data Documentation

◆ center

template<int dim, int spacedim = dim>
const Point<spacedim> HyperBallBoundary< dim, spacedim >::center
protected

Center point of the hyperball.

Definition at line 453 of file tria_boundary_lib.h.

◆ radius

template<int dim, int spacedim = dim>
const double HyperBallBoundary< dim, spacedim >::radius
protected

Radius of the hyperball.

Definition at line 458 of file tria_boundary_lib.h.

◆ compute_radius_automatically

template<int dim, int spacedim = dim>
bool HyperBallBoundary< dim, spacedim >::compute_radius_automatically
protected

This flag is false for this class and for all derived classes that set the radius by the constructor. For example this flag is false for the HalfHyperBallBoundary class but it is true for the HyperShellBoundary class, for example. The latter class doesn't get its radii by the constructor but need to compute the radii automatically each time one of the virtual functions is called.

Definition at line 468 of file tria_boundary_lib.h.


The documentation for this class was generated from the following files: