Reference documentation for deal.II version 9.5.0
\(\newcommand{\dealvcentcolon}{\mathrel{\mathop{:}}}\) \(\newcommand{\dealcoloneq}{\dealvcentcolon\mathrel{\mkern-1.2mu}=}\) \(\newcommand{\jump}[1]{\left[\!\left[ #1 \right]\!\right]}\) \(\newcommand{\average}[1]{\left\{\!\left\{ #1 \right\}\!\right\}}\)
Loading...
Searching...
No Matches
Namespaces | Macros | Functions
utilities.h File Reference
#include <deal.II/base/config.h>
#include <deal.II/base/point.h>
#include <deal.II/fe/mapping_q1.h>
#include <deal.II/grid/tria.h>
#include <string>
#include <IFSelect_ReturnStatus.hxx>
#include <TopoDS_CompSolid.hxx>
#include <TopoDS_Compound.hxx>
#include <TopoDS_Edge.hxx>
#include <TopoDS_Face.hxx>
#include <TopoDS_Shape.hxx>
#include <TopoDS_Shell.hxx>
#include <TopoDS_Solid.hxx>
#include <TopoDS_Vertex.hxx>
#include <TopoDS_Wire.hxx>
#include <gp_Pnt.hxx>

Go to the source code of this file.

Namespaces

namespace  OpenCASCADE
 

Macros

#define HAVE_CONFIG_H
 

Functions

std::tuple< unsigned int, unsigned int, unsigned intOpenCASCADE::count_elements (const TopoDS_Shape &shape)
 
TopoDS_Shape OpenCASCADE::read_IGES (const std::string &filename, const double scale_factor=1e-3)
 
void OpenCASCADE::write_IGES (const TopoDS_Shape &shape, const std::string &filename)
 
TopoDS_Shape OpenCASCADE::read_STL (const std::string &filename)
 
void OpenCASCADE::write_STL (const TopoDS_Shape &shape, const std::string &filename, const double deflection, const bool sew_different_faces=false, const double sewer_tolerance=1e-6, const bool is_relative=false, const double angular_deflection=0.5, const bool in_parallel=false)
 
TopoDS_Shape OpenCASCADE::read_STEP (const std::string &filename, const double scale_factor=1e-3)
 
void OpenCASCADE::write_STEP (const TopoDS_Shape &shape, const std::string &filename)
 
double OpenCASCADE::get_shape_tolerance (const TopoDS_Shape &shape)
 
TopoDS_Shape OpenCASCADE::intersect_plane (const TopoDS_Shape &in_shape, const double c_x, const double c_y, const double c_z, const double c, const double tolerance=1e-7)
 
TopoDS_Edge OpenCASCADE::join_edges (const TopoDS_Shape &in_shape, const double tolerance=1e-7)
 
template<int dim>
TopoDS_Edge OpenCASCADE::interpolation_curve (std::vector< Point< dim > > &curve_points, const Tensor< 1, dim > &direction=Tensor< 1, dim >(), const bool closed=false, const double tolerance=1e-7)
 
void OpenCASCADE::extract_geometrical_shapes (const TopoDS_Shape &shape, std::vector< TopoDS_Face > &faces, std::vector< TopoDS_Edge > &edges, std::vector< TopoDS_Vertex > &vertices)
 
template<int spacedim>
void OpenCASCADE::create_triangulation (const TopoDS_Face &face, Triangulation< 2, spacedim > &tria)
 
template<int spacedim>
std::vector< TopoDS_Edge > OpenCASCADE::create_curves_from_triangulation_boundary (const Triangulation< 2, spacedim > &triangulation, const Mapping< 2, spacedim > &mapping=StaticMappingQ1< 2, spacedim >::mapping)
 
void OpenCASCADE::extract_compound_shapes (const TopoDS_Shape &shape, std::vector< TopoDS_Compound > &compounds, std::vector< TopoDS_CompSolid > &compsolids, std::vector< TopoDS_Solid > &solids, std::vector< TopoDS_Shell > &shells, std::vector< TopoDS_Wire > &wires)
 
template<int dim>
std::tuple< Point< dim >, TopoDS_Shape, double, double > OpenCASCADE::project_point_and_pull_back (const TopoDS_Shape &in_shape, const Point< dim > &origin, const double tolerance=1e-7)
 
template<int dim>
Point< dim > OpenCASCADE::closest_point (const TopoDS_Shape &in_shape, const Point< dim > &origin, const double tolerance=1e-7)
 
template<int dim>
Point< dim > OpenCASCADE::push_forward (const TopoDS_Shape &in_shape, const double u, const double v)
 
std::tuple< Point< 3 >, Tensor< 1, 3 >, double, double > OpenCASCADE::push_forward_and_differential_forms (const TopoDS_Face &face, const double u, const double v, const double tolerance=1e-7)
 
std::tuple< Point< 3 >, Tensor< 1, 3 >, double, double > OpenCASCADE::closest_point_and_differential_forms (const TopoDS_Shape &in_shape, const Point< 3 > &origin, const double tolerance=1e-7)
 
template<int dim>
Point< dim > OpenCASCADE::line_intersection (const TopoDS_Shape &in_shape, const Point< dim > &origin, const Tensor< 1, dim > &direction, const double tolerance=1e-7)
 
template<int spacedim>
Point< spacedim > OpenCASCADE::point (const gp_Pnt &p, const double tolerance=1e-10)
 
template<int spacedim>
gp_Pnt OpenCASCADE::point (const Point< spacedim > &p)
 
template<int dim>
bool OpenCASCADE::point_compare (const Point< dim > &p1, const Point< dim > &p2, const Tensor< 1, dim > &direction=Tensor< 1, dim >(), const double tolerance=1e-10)
 
template<int dim>
static ::ExceptionBaseOpenCASCADE::ExcPointNotOnManifold (Point< dim > arg1)
 
template<int dim>
static ::ExceptionBaseOpenCASCADE::ExcProjectionFailed (Point< dim > arg1)
 
static ::ExceptionBaseOpenCASCADE::ExcOCCError (IFSelect_ReturnStatus arg1)
 
static ::ExceptionBaseOpenCASCADE::ExcEdgeIsDegenerate ()
 
static ::ExceptionBaseOpenCASCADE::ExcUnsupportedShape ()
 

Macro Definition Documentation

◆ HAVE_CONFIG_H

#define HAVE_CONFIG_H

Definition at line 33 of file utilities.h.