Reference documentation for deal.II version 8.5.1
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 Point< spacedim > get_new_point_on_line (const typename Triangulation< dim, spacedim >::line_iterator &line) const
 
virtual Point< spacedim > get_new_point_on_quad (const typename Triangulation< dim, spacedim >::quad_iterator &quad) const
 
virtual void get_intermediate_points_on_line (const typename Triangulation< dim, spacedim >::line_iterator &line, std::vector< Point< spacedim > > &points) const
 
virtual void get_intermediate_points_on_quad (const typename Triangulation< dim, spacedim >::quad_iterator &quad, std::vector< Point< spacedim > > &points) const
 
virtual Tensor< 1, spacedim > normal_vector (const typename Triangulation< dim, spacedim >::face_iterator &face, const Point< spacedim > &p) const
 
virtual void get_normals_at_vertices (const typename Triangulation< dim, spacedim >::face_iterator &face, typename Boundary< dim, spacedim >::FaceVertexNormals &face_vertex_normals) const
 
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
 
virtual Point< spacedim > project_to_surface (const typename Triangulation< dim, spacedim >::quad_iterator &quad, const Point< spacedim > &candidate) const
 
virtual Point< spacedim > project_to_surface (const typename Triangulation< dim, spacedim >::hex_iterator &hex, const Point< spacedim > &candidate) const
 
- Public Member Functions inherited from Boundary< dim, spacedim >
virtual ~Boundary ()
 
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 Quadrature< spacedim > &quad) const 1
 
virtual Point< spacedim > get_new_point (const std::vector< Point< spacedim > > &surrounding_points, const std::vector< double > &weights) const
 
virtual void add_new_points (const std::vector< Point< spacedim > > &surrounding_points, const Table< 2, double > &weights, std::vector< Point< spacedim > > &new_points) const
 
virtual Point< spacedim > project_to_manifold (const std::vector< Point< spacedim > > &points, const Point< spacedim > &candidate) const
 
virtual Tensor< 1, spacedim > get_tangent_vector (const Point< spacedim > &x1, const Point< spacedim > &x2) const
 
const Tensor< 1, spacedim > & get_periodicity () const
 
- Public Member Functions inherited from Manifold< dim, spacedim >
virtual ~Manifold ()
 
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 &&)
 
virtual ~Subscriptor ()
 
Subscriptoroperator= (const Subscriptor &)
 
Subscriptoroperator= (Subscriptor &&)
 
void subscribe (const char *identifier=0) const
 
void unsubscribe (const char *identifier=0) 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, char *arg2, std::string &arg3)
 
static ::ExceptionBaseExcNoSubscriber (char *arg1, char *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.

Author
Wolfgang Bangerth, 1998, Ralf Hartmann, 2001

Definition at line 320 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 481 of file tria_boundary_lib.cc.

Member Function Documentation

◆ 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
virtual

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

Reimplemented from StraightBoundary< dim, spacedim >.

Definition at line 493 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
virtual

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

Reimplemented from StraightBoundary< dim, spacedim >.

Definition at line 537 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
virtual

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 571 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
virtual

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 714 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
virtual

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 726 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
virtual

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 758 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 769 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 778 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 585 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 413 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 418 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 428 of file tria_boundary_lib.h.


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