Blender
V3.3
|
inherits from class Rep More...
Typedefs | |
using | BezierCurve = Vector2 * |
typedef struct Freestyle::Point2Struct | Point2 |
typedef Point2 | Vector2 |
typedef vector< Polygon3r * > | OccludersSet |
typedef double | real |
typedef vector< ViewShape * > | occluder_container |
typedef map< Vec3r, SVertex * > | SVertexMap |
using | segment = Segment< FEdge *, Vec3r > |
using | intersection = Intersection< segment > |
typedef Nature::EdgeNature | WXNature |
Enumerations | |
enum | IntegrationType { MEAN , MIN , MAX , FIRST , LAST } |
Functions | |
static bool | testEdgeMark (Mesh *me, const FreestyleEdge *fed, const MLoopTri *lt, int i) |
template<class Point > | |
BBox< Point > & | operator+ (const BBox< Point > &b1, const BBox< Point > &b2) |
static double * | Reparameterize (Vector2 *d, int first, int last, double *u, BezierCurve bezCurve) |
static double | NewtonRaphsonRootFind (BezierCurve Q, Vector2 P, double u) |
static Vector2 | BezierII (int degree, Vector2 *V, double t) |
static double | B0 (double u) |
static double | B1 (double u) |
static double | B2 (double u) |
static double | B3 (double u) |
static Vector2 | ComputeLeftTangent (Vector2 *d, int end) |
static double | ComputeMaxError (Vector2 *d, int first, int last, BezierCurve bezCurve, double *u, int *splitPoint) |
static double * | ChordLengthParameterize (Vector2 *d, int first, int last) |
static BezierCurve | GenerateBezier (Vector2 *d, int first, int last, double *uPrime, Vector2 tHat1, Vector2 tHat2) |
static Vector2 | V2AddII (Vector2 a, Vector2 b) |
static Vector2 | V2ScaleIII (Vector2 v, double s) |
static Vector2 | V2SubII (Vector2 a, Vector2 b) |
static double | V2SquaredLength (Vector2 *a) |
static double | V2Length (Vector2 *a) |
static Vector2 * | V2Scale (Vector2 *v, double newlen) |
static double | V2Dot (Vector2 *a, Vector2 *b) |
static double | V2DistanceBetween2Points (Vector2 *a, Vector2 *b) |
static Vector2 * | V2Add (Vector2 *a, Vector2 *b, Vector2 *c) |
static Vector2 * | V2Normalize (Vector2 *v) |
static Vector2 * | V2Negate (Vector2 *v) |
static Vector2 | ComputeRightTangent (Vector2 *d, int end) |
static Vector2 | ComputeCenterTangent (Vector2 *d, int center) |
static bool | inBox (const Vec3r &inter, const Vec3r &box_min, const Vec3r &box_max) |
static void | normalize2 (float v[2]) |
static void | normalize3 (float v[3]) |
static void | loadIdentity (double *matrix) |
static real | edgeStopping (real x, real sigma) |
static int | __recursiveSplit (Chain *_curve, UnaryFunction0D< double > &func, UnaryPredicate1D &pred, float sampling, Operators::I1DContainer &newChains, Operators::I1DContainer &splitted_chains) |
static int | __recursiveSplit (Chain *_curve, UnaryFunction0D< double > &func, UnaryPredicate0D &pred0d, UnaryPredicate1D &pred, float sampling, Operators::I1DContainer &newChains, Operators::I1DContainer &splitted_chains) |
static Stroke * | createStroke (Interface1D &inter) |
int | applyShading (Stroke &stroke, vector< StrokeShader * > &shaders) |
ostream & | operator<< (ostream &out, const StrokeAttribute &iStrokeAttribute) |
ostream & | operator<< (ostream &out, const StrokeVertex &iStrokeVertex) |
ostream & | operator<< (ostream &out, const Stroke &iStroke) |
static bool | notValid (Vec2r p) |
std::ostream & | operator<< (std::ostream &s, const Id &id) |
static real | LanczosWindowed (real t) |
static real | distance2D (const Vec3r &point, const real origin[2]) |
static bool | crossesProscenium (real proscenium[4], FEdge *fe) |
static bool | insideProscenium (const real proscenium[4], const Vec3r &point) |
template<class T > | |
T | integrate (UnaryFunction0D< T > &fun, Interface0DIterator it, Interface0DIterator it_end, IntegrationType integration_type=MEAN) |
static bool | ViewEdgeComp (ViewVertex::directedViewEdge &dve1, ViewVertex::directedViewEdge &dve2) |
template<typename G , typename I > | |
static void | findOccludee (FEdge *fe, G &, I &occluders, real epsilon, WFace **oaWFace, Vec3r &u, Vec3r &A, Vec3r &origin, Vec3r &edgeDir, vector< WVertex * > &faceVertices) |
template<typename G , typename I > | |
static void | findOccludee (FEdge *fe, G &grid, real epsilon, ViewEdge *, WFace **oaFace) |
template<typename G , typename I > | |
static int | computeVisibility (ViewMap *viewMap, FEdge *fe, G &grid, real epsilon, ViewEdge *, WFace **oaWFace, set< ViewShape * > *foundOccluders) |
template<typename G , typename I > | |
static void | computeCumulativeVisibility (ViewMap *ioViewMap, G &grid, real epsilon, RenderMonitor *iRenderMonitor) |
template<typename G , typename I > | |
static void | computeDetailedVisibility (ViewMap *ioViewMap, G &grid, real epsilon, RenderMonitor *iRenderMonitor) |
template<typename G , typename I > | |
static void | computeFastVisibility (ViewMap *ioViewMap, G &grid, real epsilon) |
template<typename G , typename I > | |
static void | computeVeryFastVisibility (ViewMap *ioViewMap, G &grid, real epsilon) |
static real | distance2D (const Vec3r &point, const real origin[2]) |
static bool | crossesProscenium (real proscenium[4], FEdge *fe) |
static bool | insideProscenium (const real proscenium[4], const Vec3r &point) |
static bool | angle_obtuse (WVertex *v, WFace *f) |
static bool | triangle_obtuse (WVertex *UNUSED(v), WFace *f) |
static real | cotan (WVertex *vo, WVertex *v1, WVertex *v2) |
static real | angle_from_cotan (WVertex *vo, WVertex *v1, WVertex *v2) |
bool | gts_vertex_mean_curvature_normal (WVertex *v, Vec3r &Kh) |
bool | gts_vertex_gaussian_curvature (WVertex *v, real *Kg) |
void | gts_vertex_principal_curvatures (real Kh, real Kg, real *K1, real *K2) |
static void | linsolve (real m11, real m12, real b1, real m21, real m22, real b2, real *x1, real *x2) |
static void | eigenvector (real a, real b, real c, Vec3r e) |
void | gts_vertex_principal_directions (WVertex *v, Vec3r Kh, real Kg, Vec3r &e1, Vec3r &e2) |
Variables | |
Controller * | g_pController |
static const int | MOD_ADLER = 65521 |
static const unsigned | NB_VALUE_NOISE = 512 |
static const real | M_EPSILON = 0.00000001 |
static unsigned | x [3] |
static unsigned | a [3] |
static unsigned | c = C |
static const Global & | _global = G |
static const unsigned | gProgressBarMaxSteps = 10 |
static const unsigned | gProgressBarMinSize = 2000 |
inherits from class Rep
using Freestyle::BezierCurve = typedef Vector2 * |
Definition at line 19 of file FitCurve.cpp.
using Freestyle::intersection = typedef Intersection<segment> |
Definition at line 2289 of file ViewMapBuilder.cpp.
typedef vector<ViewShape *> Freestyle::occluder_container |
Definition at line 41 of file Silhouette.h.
typedef vector<Polygon3r *> Freestyle::OccludersSet |
typedef struct Freestyle::Point2Struct Freestyle::Point2 |
typedef double Freestyle::real |
Definition at line 12 of file Precision.h.
using Freestyle::segment = typedef Segment<FEdge *, Vec3r> |
Definition at line 2288 of file ViewMapBuilder.cpp.
typedef map<Vec3r, SVertex *> Freestyle::SVertexMap |
Definition at line 66 of file ViewEdgeXBuilder.h.
typedef Point2 Freestyle::Vector2 |
Definition at line 52 of file FitCurve.h.
The different integration methods that can be invoked to integrate into a single value the set of values obtained from each 0D element of a 1D element.
Definition at line 34 of file Interface1D.h.
|
static |
Definition at line 848 of file Operators.cpp.
References __recursiveSplit(), Freestyle::CurveInternal::CurvePointIterator::_CurvilinearLength, Freestyle::CurveInternal::CurvePointIterator::castToInterface0DIterator(), count, Freestyle::Curve::curvePointsBegin(), Freestyle::Curve::curvePointsEnd(), Freestyle::Curve::curveVerticesBegin(), Freestyle::Curve::curveVerticesEnd(), G, G_DEBUG_FREESTYLE, Freestyle::Curve::getId(), Freestyle::Curve::getLength2D(), Freestyle::Id::getSecond(), Freestyle::Chain::getSplittingId(), next, Freestyle::Curve::nSegments(), Freestyle::Curve::push_vertex_back(), Freestyle::UnaryPredicate0D::result, Freestyle::UnaryPredicate1D::result, Freestyle::UnaryFunction0D< T >::result, Freestyle::Id::setSecond(), Freestyle::Chain::setSplittingId(), and blender::io::alembic::split().
|
static |
Definition at line 683 of file Operators.cpp.
References Freestyle::CurveInternal::CurvePointIterator::_CurvilinearLength, Freestyle::CurveInternal::CurvePointIterator::castToInterface0DIterator(), Freestyle::Curve::curvePointsBegin(), Freestyle::Curve::curvePointsEnd(), Freestyle::Curve::curveVerticesBegin(), Freestyle::Curve::curveVerticesEnd(), G, G_DEBUG_FREESTYLE, Freestyle::Curve::getId(), Freestyle::Curve::getLength2D(), Freestyle::Id::getSecond(), Freestyle::Chain::getSplittingId(), next, Freestyle::Curve::nSegments(), Freestyle::Curve::push_vertex_back(), Freestyle::UnaryPredicate1D::result, Freestyle::UnaryFunction0D< T >::result, Freestyle::Id::setSecond(), Freestyle::Chain::setSplittingId(), and blender::io::alembic::split().
Referenced by __recursiveSplit(), and Freestyle::Operators::recursiveSplit().
Definition at line 69 of file Curvature.cpp.
References KDL::atan2(), fabs(), Freestyle::WVertex::GetVertex(), sqrt(), Freestyle::VecMat::Vec< T, N >::squareNorm(), v, v1, and v2.
Referenced by gts_vertex_gaussian_curvature().
Definition at line 29 of file Curvature.cpp.
References e, Freestyle::WFace::getOppositeEdge(), and v.
Referenced by gts_vertex_principal_directions().
|
inline |
Definition at line 1249 of file Operators.cpp.
References blender::draw::image_engine::shaders.
Referenced by Freestyle::Operators::create().
Definition at line 298 of file FitCurve.cpp.
Referenced by GenerateBezier(), and mul_m4_m4m4_uniq().
Definition at line 304 of file FitCurve.cpp.
Referenced by Freestyle::ViewEdgeXBuilder::BuildSmoothFEdge(), Freestyle::ViewMapBuilder::ComputeSweepLineIntersections(), GenerateBezier(), lineart_bounding_area_link_triangle(), mul_m4_m4m4_uniq(), operator*(), and btQuaternion::operator*=().
Definition at line 310 of file FitCurve.cpp.
Referenced by Freestyle::ViewEdgeXBuilder::BuildSmoothFEdge(), Freestyle::ViewMapBuilder::ComputeSweepLineIntersections(), GenerateBezier(), mul_m4_m4m4_uniq(), operator*(), and btQuaternion::operator*=().
Definition at line 316 of file FitCurve.cpp.
Referenced by GenerateBezier(), interp_m4_m4m4(), mul_m4_m4m4_uniq(), operator*(), btQuaternion::operator*=(), and blender::robust_pred::orient2dadapt().
Definition at line 269 of file FitCurve.cpp.
Referenced by ComputeMaxError(), and NewtonRaphsonRootFind().
Definition at line 374 of file FitCurve.cpp.
References V2DistanceBetween2Points().
Referenced by Freestyle::FitCurveWrapper::FitCubic().
Definition at line 350 of file FitCurve.cpp.
References center, M_EPSILON, V2Length(), V2Normalize(), and V2SubII().
Referenced by Freestyle::FitCurveWrapper::FitCubic().
|
static |
Definition at line 422 of file ViewMapBuilder.cpp.
References _global, ceil(), count, Global::debug, blender::robust_pred::epsilon, float(), G_DEBUG_FREESTYLE, Freestyle::FEdge::getId(), Freestyle::WFace::GetNormal(), Freestyle::WVertex::GetVertex(), Freestyle::WFace::GetVertex(), Freestyle::FEdge::isInImage(), Freestyle::FEdge::nextEdge(), NULL, Freestyle::WFace::numberOfEdges(), Freestyle::RenderMonitor::progress(), Freestyle::FEdge::setaFace(), Freestyle::RenderMonitor::setInfo(), Freestyle::FEdge::setOccludeeEmpty(), Freestyle::RenderMonitor::testBreak(), Freestyle::Geometry::Polygon< Point >::userdata, Freestyle::ViewMap::ViewEdges(), Freestyle::ViewMap::viewShape(), and void.
|
static |
Definition at line 631 of file ViewMapBuilder.cpp.
References _global, Global::debug, blender::robust_pred::epsilon, float(), G_DEBUG_FREESTYLE, Freestyle::FEdge::getId(), Freestyle::WFace::GetNormal(), Freestyle::WVertex::GetVertex(), Freestyle::WFace::GetVertex(), Freestyle::FEdge::isInImage(), Freestyle::FEdge::nextEdge(), NULL, Freestyle::WFace::numberOfEdges(), Freestyle::FEdge::occluders_size(), Freestyle::FEdge::setaFace(), Freestyle::FEdge::setOccludeeEmpty(), Freestyle::RenderMonitor::testBreak(), Freestyle::Geometry::Polygon< Point >::userdata, Freestyle::ViewMap::ViewEdges(), and Freestyle::ViewMap::viewShape().
|
static |
Definition at line 814 of file ViewMapBuilder.cpp.
References _global, Global::debug, blender::robust_pred::epsilon, G_DEBUG_FREESTYLE, Freestyle::FEdge::getId(), Freestyle::WFace::GetNormal(), Freestyle::WVertex::GetVertex(), Freestyle::WFace::GetVertex(), Freestyle::FEdge::isInImage(), Freestyle::FEdge::nextEdge(), Freestyle::WFace::numberOfEdges(), Freestyle::FEdge::setaFace(), Freestyle::Geometry::Polygon< Point >::userdata, Freestyle::ViewMap::ViewEdges(), and Freestyle::ViewMap::viewShape().
Definition at line 328 of file FitCurve.cpp.
References V2Normalize(), and V2SubII().
Referenced by Freestyle::FitCurveWrapper::FitCurve().
|
static |
Definition at line 402 of file FitCurve.cpp.
References BezierII(), P(), v, V2SquaredLength(), and V2SubII().
Referenced by Freestyle::FitCurveWrapper::FitCubic().
Definition at line 339 of file FitCurve.cpp.
References V2Normalize(), and V2SubII().
Referenced by Freestyle::FitCurveWrapper::FitCurve().
|
static |
Definition at line 948 of file ViewMapBuilder.cpp.
References _global, Global::debug, blender::robust_pred::epsilon, G_DEBUG_FREESTYLE, Freestyle::WShape::GetId(), Freestyle::FEdge::getId(), Freestyle::WFace::GetNormal(), Freestyle::WVertex::GetVertex(), Freestyle::WFace::GetVertex(), Freestyle::FEdge::isInImage(), Freestyle::FEdge::nextEdge(), NULL, Freestyle::WFace::numberOfEdges(), Freestyle::FEdge::setaFace(), Freestyle::WVertex::shape(), Freestyle::Geometry::Polygon< Point >::userdata, Freestyle::ViewMap::ViewEdges(), and Freestyle::ViewMap::viewShape().
|
static |
Definition at line 204 of file ViewMapBuilder.cpp.
References _global, center, Freestyle::FEdge::center3d(), Freestyle::GeomUtils::COINCIDENT, Global::debug, blender::robust_pred::epsilon, fabs(), Freestyle::FEdgeSmooth::face(), G_DEBUG_FREESTYLE, Freestyle::WFace::getEdgeList(), Freestyle::WShape::GetId(), Freestyle::WFace::GetNormal(), Freestyle::Geometry::Polygon3r::getNormal(), Freestyle::WFace::GetVertex(), Freestyle::Geometry::Polygon< Point >::getVertices(), I, Freestyle::GeomUtils::intersectRayPlane(), Freestyle::FEdge::isSmooth(), Freestyle::VecMat::Vec< T, N >::norm(), Freestyle::VecMat::Vec< T, N >::normalize(), Freestyle::SVertex::point3D(), Freestyle::Geometry::Polygon3r::rayIntersect(), Freestyle::WFace::RetrieveVertexList(), Freestyle::WVertex::shape(), t, v, v1, Freestyle::FEdge::vertexA(), Freestyle::FEdge::vertexB(), Freestyle::ViewMap::viewShape(), and x.
Definition at line 50 of file Curvature.cpp.
References Freestyle::WVertex::GetVertex(), sqrt(), Freestyle::VecMat::Vec< T, N >::squareNorm(), v, v1, and v2.
Referenced by gts_vertex_mean_curvature_normal(), and gts_vertex_principal_directions().
|
static |
Definition at line 1070 of file Operators.cpp.
References ELEM, G, G_DEBUG_FREESTYLE, Freestyle::Interface1D::getId(), Freestyle::StrokeVertex::getPoint(), Freestyle::CurvePoint::getPoint2D(), Freestyle::Interface0D::getPoint2D(), Freestyle::StrokeInternal::StrokeVertexIterator::isBegin(), Freestyle::StrokeInternal::StrokeVertexIterator::isEnd(), Freestyle::Interface0DIterator::isEnd(), len, next, norm(), Freestyle::VecMat::Vec< T, N >::norm(), Freestyle::VecMat::Vec< T, N >::normalize(), offset, Freestyle::Stroke::push_back(), Freestyle::StrokeVertex::setCurvilinearAbscissa(), Freestyle::Stroke::setId(), Freestyle::Stroke::setLength(), Freestyle::StrokeVertex::setPoint(), Freestyle::Stroke::strokeVerticesBegin(), Freestyle::Stroke::strokeVerticesSize(), v, Freestyle::Stroke::verticesBegin(), Freestyle::Interface1D::verticesBegin(), and Freestyle::Interface1D::verticesEnd().
Referenced by Freestyle::Operators::create().
Definition at line 69 of file CulledOccluderSource.cpp.
References A, B, Freestyle::SVertex::getProjectedX(), Freestyle::SVertex::getProjectedY(), Freestyle::GeomUtils::intersect2dSeg2dArea(), max, min, Freestyle::FEdge::vertexA(), and Freestyle::FEdge::vertexB().
Referenced by Freestyle::CulledOccluderSource::cullViewEdges(), and Freestyle::ViewMapBuilder::CullViewEdges().
Definition at line 1062 of file ViewMapBuilder.cpp.
References A, B, Freestyle::SVertex::getProjectedX(), Freestyle::SVertex::getProjectedY(), Freestyle::GeomUtils::intersect2dSeg2dArea(), max, min, Freestyle::FEdge::vertexA(), and Freestyle::FEdge::vertexB().
Definition at line 64 of file CulledOccluderSource.cpp.
References KDL::hypot(), and point.
Referenced by Freestyle::CulledOccluderSource::cullViewEdges(), and Freestyle::ViewMapBuilder::CullViewEdges().
Definition at line 1057 of file ViewMapBuilder.cpp.
References KDL::hypot(), and point.
Definition at line 236 of file AdvancedStrokeShaders.cpp.
Referenced by Freestyle::Smoother::iteration().
Definition at line 198 of file Curvature.cpp.
References a, usdtokens::b(), c, e, and sqrt().
Referenced by gts_vertex_principal_directions().
|
static |
Definition at line 39 of file ViewMapBuilder.cpp.
References _global, A, Freestyle::Nature::BORDER, Freestyle::GeomUtils::COINCIDENT, Global::debug, blender::robust_pred::epsilon, fabs(), Freestyle::FEdgeSmooth::face(), G_DEBUG_FREESTYLE, Freestyle::Geometry::Polygon3r::getNormal(), Freestyle::Geometry::Polygon< Point >::getVertices(), Freestyle::GeomUtils::intersectRayPlane(), Freestyle::FEdge::isSmooth(), Freestyle::Geometry::Polygon3r::rayIntersect(), Freestyle::FEdge::setOccludeeIntersection(), Freestyle::Nature::SILHOUETTE, t, and v.
|
static |
Definition at line 167 of file ViewMapBuilder.cpp.
References A, blender::robust_pred::epsilon, Freestyle::FEdgeSmooth::face(), I, Freestyle::FEdge::isSmooth(), Freestyle::VecMat::Vec< T, N >::normalize(), and Freestyle::WFace::RetrieveVertexList().
|
static |
Definition at line 109 of file FitCurve.cpp.
References A, B0(), B1(), B2(), B3(), C, V2Add(), V2AddII(), V2DistanceBetween2Points(), V2Dot(), V2Scale(), V2ScaleIII(), V2SubII(), and X.
Referenced by Freestyle::FitCurveWrapper::FitCubic().
v | a #WVertex. |
Kg | the Discrete Gaussian Curvature approximation at v. |
Computes the Discrete Gaussian Curvature approximation at v.
This approximation is from the paper: Discrete Differential-Geometry Operators for Triangulated 2-Manifolds Mark Meyer, Mathieu Desbrun, Peter Schroder, Alan H. Barr VisMath '02, Berlin (Germany) http://www-grail.usc.edu/pubs.html
Returns: true if the operator could be evaluated, false if the evaluation failed for some reason (v
is boundary or is the endpoint of a non-manifold edge.)
Definition at line 136 of file Curvature.cpp.
References angle_from_cotan(), blender::compositor::area(), e, M_PI, v, v1, and v2.
v | a #WVertex. |
Kh | the Mean Curvature Normal at v. |
Computes the Discrete Mean Curvature Normal approximation at v. The mean curvature at v is half the magnitude of the vector Kh.
This approximation is from the paper: Discrete Differential-Geometry Operators for Triangulated 2-Manifolds Mark Meyer, Mathieu Desbrun, Peter Schroder, Alan H. Barr VisMath '02, Berlin (Germany) http://www-grail.usc.edu/pubs.html
Returns: true if the operator could be evaluated, false if the evaluation failed for some reason (v
is boundary or is the endpoint of a non-manifold edge.)
Definition at line 86 of file Curvature.cpp.
References blender::compositor::area(), cotan(), e, v, v1, and v2.
Kh | mean curvature. |
Kg | Gaussian curvature. |
K1 | first principal curvature. |
K2 | second principal curvature. |
Computes the principal curvatures at a point given the mean and Gaussian curvatures at that point.
The mean curvature can be computed as one-half the magnitude of the vector computed by gts_vertex_mean_curvature_normal().
The Gaussian curvature can be computed with gts_vertex_gaussian_curvature().
Definition at line 171 of file Curvature.cpp.
References sqrt().
Referenced by gts_vertex_principal_directions().
void Freestyle::gts_vertex_principal_directions | ( | WVertex * | v, |
Vec3r | Kh, | ||
real | Kg, | ||
Vec3r & | e1, | ||
Vec3r & | e2 | ||
) |
v | a #WVertex. |
Kh | mean curvature normal (a #Vec3r). |
Kg | Gaussian curvature (a real). |
e1 | first principal curvature direction (direction of largest curvature). |
e2 | second principal curvature direction. |
Computes the principal curvature directions at a point given Kh and Kg, the mean curvature normal and Gaussian curvatures at that point, computed with gts_vertex_mean_curvature_normal() and gts_vertex_gaussian_curvature(), respectively.
Note that this computation is very approximate and tends to be unstable. Smoothing of the surface or the principal directions may be necessary to achieve reasonable results.
Definition at line 210 of file Curvature.cpp.
References a, angle_obtuse(), usdtokens::b(), c, cotan(), e, eigenvector(), fabs(), free(), Freestyle::WFace::getArea(), Freestyle::WOEdge::GetbVertex(), Freestyle::WFace::GetNextOEdge(), gts_vertex_principal_curvatures(), linsolve(), N, Freestyle::VecMat::Vec< T, N >::norm(), Freestyle::VecMat::Vec< T, N >::normalize(), Freestyle::VecMat::Vec< T, N >::squareNorm(), triangle_obtuse(), and v.
|
static |
Definition at line 24 of file Grid.cpp.
References Freestyle::VecMat::Vec3< T >::x(), Freestyle::VecMat::Vec3< T >::y(), and Freestyle::VecMat::Vec3< T >::z().
Referenced by Freestyle::firstIntersectionGridVisitor::examineOccluder().
|
inlinestatic |
Definition at line 79 of file CulledOccluderSource.cpp.
References point.
Referenced by Freestyle::CulledOccluderSource::cullViewEdges(), and Freestyle::ViewMapBuilder::CullViewEdges().
|
inlinestatic |
Definition at line 1072 of file ViewMapBuilder.cpp.
References point.
T Freestyle::integrate | ( | UnaryFunction0D< T > & | fun, |
Interface0DIterator | it, | ||
Interface0DIterator | it_end, | ||
IntegrationType | integration_type = MEAN |
||
) |
Returns a single value from a set of values evaluated at each 0D element of this 1D element.
fun | The UnaryFunction0D used to compute a value at each Interface0D. |
it | The Interface0DIterator used to iterate over the 0D elements of this 1D element. The integration will occur over the 0D elements starting from the one pointed by it. |
it_end | The Interface0DIterator pointing the end of the 0D elements of the 1D element. |
integration_type | The integration method used to compute a single value from a set of values. |
Definition at line 73 of file Interface1D.h.
References FIRST, Freestyle::Interface0DIterator::isEnd(), LAST, MAX, MEAN, MIN, Freestyle::UnaryFunction0D< T >::result, size(), and T.
Referenced by Integrator_integrate(), Freestyle::Functions1D::DensityF1D::operator()(), Freestyle::Functions1D::LocalAverageDepthF1D::operator()(), Freestyle::Functions1D::GetCompleteViewMapDensityF1D::operator()(), Freestyle::Functions1D::GetDirectionalViewMapDensityF1D::operator()(), Freestyle::Functions1D::GetViewMapGradientNormF1D::operator()(), Freestyle::Functions1D::GetXF1D::operator()(), Freestyle::Functions1D::GetYF1D::operator()(), Freestyle::Functions1D::GetZF1D::operator()(), Freestyle::Functions1D::GetProjectedXF1D::operator()(), Freestyle::Functions1D::GetProjectedYF1D::operator()(), Freestyle::Functions1D::GetProjectedZF1D::operator()(), Freestyle::Functions1D::Orientation2DF1D::operator()(), Freestyle::Functions1D::Orientation3DF1D::operator()(), Freestyle::Functions1D::ZDiscontinuityF1D::operator()(), Freestyle::Functions1D::QuantitativeInvisibilityF1D::operator()(), Freestyle::Functions1D::Curvature2DAngleF1D::operator()(), and Freestyle::Functions1D::Normal2DF1D::operator()().
Definition at line 47 of file PseudoNoise.cpp.
References fabs(), M_EPSILON, M_PI, KDL::sin(), and t.
Referenced by Freestyle::PseudoNoise::smoothNoise().
|
static |
Definition at line 188 of file Curvature.cpp.
References x2.
Referenced by gts_vertex_principal_directions().
Definition at line 15 of file NodeCamera.cpp.
Referenced by Freestyle::NodeCamera::NodeCamera(), Freestyle::NodeOrthographicCamera::NodeOrthographicCamera(), and Freestyle::NodePerspectiveCamera::NodePerspectiveCamera().
|
static |
Definition at line 222 of file FitCurve.cpp.
References BezierII(), and P().
Referenced by Reparameterize().
Definition at line 53 of file Noise.cpp.
Referenced by Freestyle::Noise::Noise().
Definition at line 62 of file Noise.cpp.
Referenced by Freestyle::Noise::Noise().
Definition at line 89 of file StrokeRep.cpp.
References fabs(), and HUGE_COORD.
Referenced by Freestyle::Strip::cleanUpSingularities(), and Freestyle::Strip::createStrip().
BBox<Point>& Freestyle::operator+ | ( | const BBox< Point > & | b1, |
const BBox< Point > & | b2 | ||
) |
Definition at line 130 of file BBox.h.
References Freestyle::BBox< Point >::getMax(), and Freestyle::BBox< Point >::getMin().
ostream & Freestyle::operator<< | ( | ostream & | out, |
const Stroke & | iStroke | ||
) |
Definition at line 39 of file StrokeIO.cpp.
References Freestyle::Stroke::getId(), Freestyle::Stroke::getLength2D(), Freestyle::Stroke::getMediumType(), usdtokens::out(), v, Freestyle::Stroke::vertices_begin(), and Freestyle::Stroke::vertices_end().
ostream & Freestyle::operator<< | ( | ostream & | out, |
const StrokeAttribute & | iStrokeAttribute | ||
) |
Definition at line 14 of file StrokeIO.cpp.
References Freestyle::StrokeAttribute::getAlpha(), Freestyle::StrokeAttribute::getColorB(), Freestyle::StrokeAttribute::getColorG(), Freestyle::StrokeAttribute::getColorR(), Freestyle::StrokeAttribute::getThicknessL(), Freestyle::StrokeAttribute::getThicknessR(), Freestyle::StrokeAttribute::isVisible(), and usdtokens::out().
ostream & Freestyle::operator<< | ( | ostream & | out, |
const StrokeVertex & | iStrokeVertex | ||
) |
Definition at line 26 of file StrokeIO.cpp.
References Freestyle::StrokeVertex::attribute(), Freestyle::StrokeVertex::curvilinearAbscissa(), Freestyle::CurvePoint::getId(), Freestyle::CurvePoint::getProjectedX(), Freestyle::CurvePoint::getProjectedY(), Freestyle::CurvePoint::getProjectedZ(), Freestyle::CurvePoint::getX(), Freestyle::CurvePoint::getY(), Freestyle::CurvePoint::getZ(), and usdtokens::out().
|
inline |
|
static |
Definition at line 202 of file FitCurve.cpp.
References NewtonRaphsonRootFind().
Referenced by Freestyle::FitCurveWrapper::FitCubic().
|
static |
Definition at line 374 of file BlenderFileLoader.cpp.
References MLoop::e, ELEM, FreestyleEdge::flag, FREESTYLE_EDGE_MARK, Mesh::medge, Mesh::mloop, MLoopTri::tri, MLoop::v, MEdge::v1, and MEdge::v2.
Referenced by Freestyle::BlenderFileLoader::insertShapeNode().
Definition at line 41 of file Curvature.cpp.
References usdtokens::b(), and Freestyle::WFace::getEdgeList().
Referenced by gts_vertex_principal_directions().
Definition at line 76 of file FitCurve.cpp.
References c.
Referenced by Freestyle::FitCurveWrapper::FitCubic(), and GenerateBezier().
Definition at line 425 of file FitCurve.cpp.
References a, usdtokens::b(), and c.
Referenced by GenerateBezier().
Definition at line 68 of file FitCurve.cpp.
References sqrt().
Referenced by ChordLengthParameterize(), Freestyle::FitCurveWrapper::FitCubic(), and GenerateBezier().
Definition at line 62 of file FitCurve.cpp.
References a, and usdtokens::b().
Referenced by GenerateBezier().
Definition at line 46 of file FitCurve.cpp.
References a, sqrt(), and V2SquaredLength().
Referenced by ComputeCenterTangent(), V2Normalize(), and V2Scale().
Definition at line 95 of file FitCurve.cpp.
References v.
Referenced by Freestyle::FitCurveWrapper::FitCubic().
Definition at line 84 of file FitCurve.cpp.
References len, v, and V2Length().
Referenced by ComputeCenterTangent(), ComputeLeftTangent(), and ComputeRightTangent().
Definition at line 51 of file FitCurve.cpp.
References len, v, and V2Length().
Referenced by Freestyle::FitCurveWrapper::FitCubic(), and GenerateBezier().
Definition at line 433 of file FitCurve.cpp.
Referenced by GenerateBezier().
Definition at line 40 of file FitCurve.cpp.
References a.
Referenced by ComputeMaxError(), and V2Length().
Definition at line 441 of file FitCurve.cpp.
References a, usdtokens::b(), and c.
Referenced by ComputeCenterTangent(), ComputeLeftTangent(), ComputeMaxError(), ComputeRightTangent(), and GenerateBezier().
|
static |
Definition at line 285 of file ViewMap.cpp.
References Freestyle::FEdge::orientation2d(), v1, v2, Freestyle::VecMat::Vec3< T >::x(), and Freestyle::VecMat::Vec3< T >::y().
Referenced by Freestyle::NonTVertex::AddIncomingViewEdge(), Freestyle::NonTVertex::AddOutgoingViewEdge(), Freestyle::TVertex::setBackEdgeA(), Freestyle::TVertex::setBackEdgeB(), Freestyle::TVertex::setFrontEdgeA(), and Freestyle::TVertex::setFrontEdgeB().
Definition at line 32 of file ViewMapBuilder.cpp.
Referenced by Freestyle::ViewMapBuilder::BuildGrid(), computeCumulativeVisibility(), computeDetailedVisibility(), Freestyle::ViewMapBuilder::ComputeEdgesVisibility(), computeFastVisibility(), Freestyle::ViewMapBuilder::ComputeIntersections(), Freestyle::ViewMapBuilder::ComputeRayCastingVisibility(), Freestyle::ViewMapBuilder::ComputeSweepLineIntersections(), computeVeryFastVisibility(), computeVisibility(), Freestyle::ViewMapBuilder::CullViewEdges(), and findOccludee().
|
static |
Definition at line 78 of file RandGen.cpp.
Referenced by _btMprVec3PointSegmentDist2(), _clamp(), _face_calcIFNo(), _glewStrSame(), _scan_for_ext_spring_forces(), abs(), blender::math::abs(), abs_intptr(), abs_v2_v2(), abs_v3_v3(), abs_v4_v4(), KDL::acos(), Add(), add_2nd_order_roller(), add_bezier(), add_eul_euleul(), blender::bke::add_implicit_conversion(), add_main_to_main(), InstanceWriter::add_material_bindings(), add_mesh_quad_diag_springs(), SVMCompiler::add_node(), add_qt_qtqt(), add_sh_shsh(), add_stroke_cyclic(), blender::io::stl::STLMeshHelper::add_triangle(), blender::tests::add_two_numbers(), add_v2_v2(), add_v2_v2_db(), add_v2_v2_int(), add_v2_v2v2(), add_v2_v2v2_int(), add_v3_v3(), add_v3_v3_atomic(), add_v3_v3_db(), add_v3_v3v3(), add_v3fl_v3fl_v3i(), add_v4_v4(), add_v4_v4v4(), KDL::addDelta(), addDelta(), adduplicateflagNurb(), blender::math::almost_equal_relative(), angle_normalized_v2v2(), angle_v2v2(), angle_v2v2v2(), angle_v3v3(), angle_v3v3v3(), animdata_filter_ds_materials(), animdata_filter_ds_textures(), annotation_add_missing_events(), annotation_smooth_buffer(), blender::compositor::antialias_tagbuf(), api_string(), btSoftBody::appendAnchor(), apply_spring_memory(), AreaOf(), arena_alloc(), arena_realloc(), arena_release(), armature_click_extrude_exec(), armature_extrude_exec(), as_float2(), KDL::asin(), KDL::atan(), KDL::atan2(), attr_align(), attr_size(), average(), average_grid_element_value_v3(), avxf::avxf(), avxi::avxi(), balance_heuristic(), balance_heuristic_3(), BaryCoord(), btSoftBody::BaryEval(), BaryEval(), BatchCompare(), bc_bubble_sort_by_Object_name(), bc_copy_darray_m4d(), bc_copy_farray_m4(), bc_copy_m4_farray(), bc_copy_m4d_v44(), bc_copy_v44_m4d(), bc_get_cot(), bc_has_animations(), bc_in_range(), berekeny(), blender::ed::space_node::best_socket_input(), bev_ccw_test(), bevel_list_smooth(), bezier_eq_continuous(), bezier_eq_noaccel_left(), bezier_eq_noaccel_right(), bezier_handle_calc_smooth_fcurve(), bezier_lock_unknown(), bezier_relax_direction(), bezier_restore_equation(), bicubic_interpolation(), bilinear_interpolation(), bilinear_interpolation_color_wrap(), bisect_v3_v3v3v3(), bitscan_forward_clear_i(), bitscan_forward_clear_uint(), bitscan_forward_i(), bitscan_forward_uint(), bitscan_forward_uint64(), bitscan_reverse_clear_i(), bitscan_reverse_clear_uint(), bitscan_reverse_i(), bitscan_reverse_uint(), bitscan_reverse_uint64(), BKE_blendfile_write_partial(), BKE_colorband_element_remove(), BKE_colorband_evaluate(), BKE_colorband_evaluate_table_rgba(), BKE_colorband_init(), BKE_colorband_update_sort(), BKE_crazyspace_build_sculpt(), BKE_crazyspace_get_first_deform_matrices_editbmesh(), BKE_curve_bevelList_make(), BKE_curve_forward_diff_bezier(), BKE_curve_forward_diff_tangent_bezier(), BKE_curve_texspace_calc(), BKE_curvemap_handle_set(), BKE_curvemap_insert(), BKE_curvemap_remove(), BKE_curvemap_remove_point(), BKE_curvemapping_blend_read(), BKE_curvemapping_changed(), BKE_curvemapping_changed_all(), BKE_curvemapping_copy_data(), BKE_curvemapping_curves_blend_write(), BKE_curvemapping_free_data(), BKE_curvemapping_init(), BKE_curvemapping_premultiply(), BKE_curvemapping_RGBA_does_something(), BKE_curvemapping_set_black_white_ex(), BKE_curvemapping_set_defaults(), BKE_curvemapping_table_F(), BKE_curvemapping_table_RGBA(), BKE_displist_normals_add(), BKE_displist_surfindex_get(), BKE_fcurve_handles_recalc_ex(), BKE_gpencil_stroke_trim(), BKE_id_materials_copy(), BKE_image_paint_set_mipmap(), BKE_image_render_write_exr(), BKE_keyblock_convert_to_vertcos(), BKE_keyblock_curve_data_transform(), BKE_keyblock_update_from_curve(), BKE_keyblock_update_from_lattice(), BKE_keyblock_update_from_mesh(), BKE_keyblock_update_from_offset(), BKE_keyblock_update_from_vertcos(), BKE_lattice_is_any_selected(), BKE_library_make_local(), BKE_main_free(), BKE_main_id_flag_all(), BKE_main_id_tag_all(), BKE_mask_spline_differentiate_with_resolution(), BKE_mask_spline_resolution(), BKE_mball_make_orco(), BKE_mball_polygonize(), BKE_mesh_from_metaball(), BKE_mesh_merge_customdata_for_apply_modifier(), BKE_mesh_mirror_apply_mirror_on_axis_for_modifier(), BKE_mesh_nomain_to_meshkey(), BKE_mesh_orco_verts_get(), BKE_mesh_orco_verts_transform(), BKE_mesh_strip_loose_edges(), BKE_mesh_strip_loose_faces(), BKE_mesh_strip_loose_polysloops(), BKE_mesh_texspace_calc(), BKE_mesh_uv_vert_map_create(), BKE_modifier_mdef_compact_influences(), BKE_nurb_calc_length(), BKE_nurb_direction_switch(), BKE_nurb_handles_test(), BKE_nurb_minmax(), BKE_nurb_project_2d(), BKE_nurb_type_convert(), BKE_nurbList_flag_set(), BKE_nurbList_handles_recalculate(), BKE_nurbList_handles_set(), BKE_object_as_kdtree(), BKE_object_defgroup_remap_update_users(), BKE_object_material_slot_find_index(), BKE_object_material_slot_remove(), BKE_particle_system_blend_read_data(), BKE_particle_system_blend_write(), BKE_pbvh_draw_debug_cb(), BKE_pbvh_grids_update(), BKE_pbvh_vert_coords_alloc(), BKE_pbvh_vert_coords_apply(), BKE_pchan_bbone_segments_cache_compute(), BKE_pchan_bbone_spline_compute(), BKE_pose_rest(), BKE_scene_validate_setscene(), BKE_scopes_update(), BKE_screen_remove_unused_scredges(), BKE_sim_debug_data_hash_combine(), BKE_tracking_camera_get_reconstructed(), BKE_tracking_camera_get_reconstructed_interpolate(), BKE_tracking_marker_clamp_pattern_position(), BKE_tracking_marker_clamp_search_position(), BKE_tracking_marker_clamp_search_size(), BKE_tracking_marker_delete(), BKE_tracking_marker_insert(), BKE_tracking_max_distortion_delta_across_bound(), BKE_tracking_plane_marker_delete(), BKE_tracking_plane_marker_get(), BKE_tracking_plane_marker_insert(), BKE_tracking_sample_pattern(), BKE_tracking_tracks_join(), blend(), BLF_color4f(), blf_font_draw_buffer_ex(), BLI_args_parse(), BLI_args_print_arg_doc(), BLI_ewa_filter(), BLI_ewa_imp2radangle(), BLI_ghashutil_intcmp(), BLI_ghashutil_paircmp(), BLI_ghashutil_ptrcmp(), BLI_ghashutil_strcmp(), BLI_ghashutil_uinthash_v4_cmp(), BLI_hash_int_2d(), BLI_hash_int_3d(), blender::vec_base< T, Size >::BLI_INT_OP(), BLI_lasso_boundbox(), BLI_lasso_is_edge_inside(), BLI_listbase_equal(), blender::color::BLI_mix_colors(), BLI_path_extension_ensure(), BLI_path_extension_replace(), BLI_path_normalize(), BLI_path_suffix(), BLI_qsort_r(), BLI_quadric_add_qu_qu(), BLI_quadric_add_qu_ququ(), BLI_quadric_mul(), BLI_scanfill_calc_ex(), BLI_sortutil_cmp_float(), BLI_sortutil_cmp_float_reverse(), BLI_sortutil_cmp_int(), BLI_sortutil_cmp_int_reverse(), BLI_sortutil_cmp_ptr(), BLI_sortutil_cmp_ptr_reverse(), BLI_split_name_num(), BLI_strcaseeq(), BLI_string_search_query(), BLI_threadpool_init(), BLI_tridiagonal_solve(), BLI_tridiagonal_solve_cyclic(), blo_do_versions_250(), blo_do_versions_260(), blo_do_versions_270(), blo_do_versions_pre250(), BLO_expand_main(), BVHObjectBinning::blocks(), bm_isect_tri_tri(), bm_loop_index_cmp(), BM_uv_vert_map_create(), bmo_create_circle_exec(), bmo_create_icosphere_exec(), bmo_create_uvsphere_exec(), bmo_spin_exec(), bmo_subdivide_edges_exec(), bone_mouse_select_menu(), bone_skinnable_cb(), blender::bke::bool_to_byte_color(), blender::bke::bool_to_color(), blender::bke::bool_to_float(), blender::bke::bool_to_float2(), blender::bke::bool_to_float3(), blender::bke::bool_to_int(), blender::bke::bool_to_int8(), box_clip_bounds_m4(), box_minmax_bounds_m4(), BPy_Nature_and(), BPy_Nature_bitwise(), BPy_Nature_or(), BPy_Nature_xor(), brightcontrast_apply_threaded(), bsdf_beckmann_aniso_G1(), bsdf_beckmann_G1(), btClamp(), btClamped(), btComputeGjkDistance(), btComputeGjkEpaPenetration(), btComputeMprPenetration(), btDiscoverPortal(), btEqual(), btFindOrigin(), btFindPenetr(), btFsel(), btGjkEpaCalcPenDepth(), btGjkEpaSolver3_Distance(), btGjkEpaSolver3_Penetration(), btGreaterEqual(), btLargeDot(), btLDLTAddTL(), btLDLTRemove(), btMax(), btMin(), btMprEq(), btMprPenetration(), btMprSimplexSet(), btMprSupport(), btMprVec3Cross(), btMprVec3Dist2(), btMprVec3Dot(), btMprVec3PointTriDist2(), btPlaneSpace1(), btRefinePortal(), btSetMax(), btSetMin(), btSetZero(), btSimplexSet(), btSwap(), btSwapEndianFloat(), btTripleCross(), btUnswapEndianFloat(), btVec3Cross(), btVec3Dot(), btVec3Eq(), btVec3PointSegmentDist2(), btVec3PointTriDist2(), btVectorScale(), buf_rectfill_area(), build_bps_springlist(), blender::compositor::KeyingScreenOperation::build_voronoi_triangulation(), blender::ed::outliner::TreeDisplayIDOrphans::buildTree(), buttons_texture_users_from_context(), bvh_insertionsort(), bvh_medianof3(), bvh_partition(), blender::bke::byte_color_to_bool(), blender::bke::byte_color_to_color(), blender::bke::byte_color_to_float(), blender::bke::byte_color_to_float2(), blender::bke::byte_color_to_float3(), blender::bke::byte_color_to_int(), blender::bke::byte_color_to_int8(), calc_edge_mat(), calc_keyHandles(), blender::io::obj::OBJMesh::calc_poly_order(), calc_shapeKeys(), calcArea4Points(), calchandlesNurb_intern(), blender::bke::curves::catmull_rom::calculate_basis(), calculate_collision_balls(), calculate_struct_sizes(), calculatePrincipalAxisTransform(), blender::fn::tests::ConcatVectorsFunction::call(), camera_view3d_reconstruction(), cancel_mouse_slide(), cancelTransTracking(), cast(), cast_pointer_32_to_64(), cast_pointer_64_to_32(), cast_primitive_type(), ccdEq(), ccdVec3Dist2(), ccgDM_get_edge_data_layer(), ccgDM_get_poly_data_layer(), ccgDM_get_vert_data_layer(), ccl_try_align(), cdf_layer_find(), cdf_read_header(), cdf_read_layer(), cdf_write_header(), ceil(), blender::math::ceil(), blender::math::ceil_to_multiple(), ceil_to_multiple_u(), ceil_to_multiple_ul(), channels_alpha_inverse_sort(), channels_alpha_sort(), channels_average_error_inverse_sort(), channels_average_error_sort(), channels_end_inverse_sort(), channels_end_sort(), channels_longest_segment_inverse_sort(), channels_longest_segment_sort(), channels_start_inverse_sort(), channels_start_sort(), channels_total_track_inverse_sort(), channels_total_track_sort(), choose_api(), choose_winner(), circball_array_fill(), circle_dashed_verts(), circle_verts(), blender::math::clamp(), clamp(), clear_tilt_exec(), btPolyhedralContactClipping::clipFaceAgainstHull(), clipUVData(), clipx_rctf_swap(), clipy_rctf_swap(), closer_v3_v3v3v3(), closestPtPointTetrahedron(), closestPtPointTriangle(), cloth_continuum_step(), cmp_adjacent_items(), cmp_def_property(), cmp_def_struct(), cmp_fn(), cmp_property(), cmp_struct(), blender::nodes::node_geo_curve_primitive_arc_cc::colinear_f3_f3_f3(), blender::nodes::node_geo_curve_primitive_circle_cc::colinear_f3_f3_f3(), collision_compute_barycentric(), blender::compositor::color_diff(), color_float4_to_uchar4(), Color_richcmpr(), blender::bke::color_to_bool(), blender::bke::color_to_byte_color(), blender::bke::color_to_float(), blender::bke::color_to_float2(), blender::bke::color_to_float3(), blender::bke::color_to_int(), blender::bke::color_to_int8(), colorband_distribute_cb(), colorband_flip_cb(), colorfn(), colormanage_hashcmp(), comp_float_int_pair(), btConvexHullInternal::Rational128::compare(), compare_ff(), compare_ff_relative(), compare_floats(), compare_int(), blender::ed::space_node::compare_nodes(), compare_packtile(), compare_panel(), compare_pass_order(), CompGreater(), CompLess(), blender::nodes::node_fn_compare_cc::component_average(), compress_reconstruct_steps(), GivensRotation::compute(), compute_collision_point_edge_tri(), compute_collision_point_tri_tri(), libmv::euclidean_resection::ComputeBarycentricCoordinates(), GivensRotation::computeUnconventional(), concentric_sample_disk(), btDbvtAabbMm::Contain(), continuousCollisionDetection(), convert_channels(), convert_pose(), convert_tree(), convertCbYCrA_RGBA(), coplanar(), copy_qt_qt(), copy_sh_sh(), copy_v2_uchar(), copy_v2_v2(), copy_v2_v2_char(), copy_v2_v2_db(), copy_v2_v2_int(), copy_v2_v2_short(), copy_v2_v2_uchar(), copy_v2db_v2fl(), copy_v2fl_v2db(), copy_v2fl_v2i(), copy_v3_uchar(), copy_v3_v3(), copy_v3_v3_char(), copy_v3_v3_db(), copy_v3_v3_int(), copy_v3_v3_map(), copy_v3_v3_short(), copy_v3_v3_uchar(), copy_v3_v3_unmap(), copy_v3db_v3fl(), copy_v3fl_v3db(), copy_v3fl_v3s(), copy_v4_uchar(), copy_v4_v4(), copy_v4_v4_char(), copy_v4_v4_db(), copy_v4_v4_int(), copy_v4_v4_short(), copy_v4_v4_uchar(), copy_v4db_v4fl(), copy_v4fl_v4db(), KDL::cos(), KDL::cosh(), cotangent_tri_weight_v3(), count_mesh_quads(), covariance_m_vn_ex_task_cb(), cp_cu_key(), cp_key(), crazyspace_init_verts_and_matrices(), blender::nodes::node_geo_curve_primitive_arc_cc::create_arc_curve_from_points(), create_edge_from_corner(), GeometryExporter::create_mesh_primitive_list(), create_split_edge_from_corner(), btSoftBodyHelpers::CreateEllipsoid(), GeometryExporter::createTexcoordsSource(), createTransCurveVerts(), createTransEditVerts(), createTransLatticeVerts(), createTransMeshSkin(), createTransMeshVertCData(), GeometryExporter::createVertexColorSource(), cross(), blender::math::cross(), blender::math::cross_high_precision(), cross_poly_v2(), cross_v2v2(), cross_v2v2_db(), cross_v3_v3v3(), cross_v3_v3v3_db(), cross_v3_v3v3_hi_prec(), crossProduct(), CSqrt(), CTX_data_dir_get_ex(), cube_d(), cube_f(), cube_i(), cube_s(), cube_uchar(), cube_uint(), cubic_g0(), cubic_g1(), cubic_h0(), cubic_h1(), cubic_interp(), cubic_w0(), cubic_w1(), cubic_w2(), cubic_w3(), cullPoints2(), curve_blend_read_expand(), curve_blend_read_lib(), curve_calc_dist_pair(), curve_create_edit_data_and_handles(), curve_deform_coords_impl(), curve_delete_segments(), curve_rename_fcurves(), curve_select_less(), curve_select_more(), curve_select_random_exec(), curve_smooth_value(), curve_surf_to_softbody(), curve_toggle_cyclic(), curvemap_buttons_reset(), curvemap_make_table(), curves_blend_read_expand(), curves_blend_read_lib(), customdata_version_242(), customdata_version_243(), blender::string_search::damerau_levenshtein_distance(), dblSort3(), dDOT(), dDOT14(), dDOT41(), dDOT44(), debug_element_compare(), btCollisionWorld::debugDrawObject(), btPolarDecomposition::decompose(), deformMatrices(), deformMatricesEM(), delete_knot_exec(), btCollisionWorldImporter::deleteAllData(), gjkepa2_impl::GJK::det(), GJK< btConvexTemplate >::det(), detect_retrieve_libmv_features(), determinant_m2(), dgroup_skinnable_cb(), KDL::Frame::DH(), KDL::Frame::DH_Craig1989(), KDL::diff(), diff(), diffSign(), blender::Set< Key, InlineBufferCapacity, ProbingStrategy, Hash, IsEqual, Slot, Allocator >::Disjoint(), displist_calc_taper(), displist_surf_indices(), dist_tent_v3f3(), distance(), float3::distance(), blender::math::distance(), blender::math::distance_manhattan(), blender::math::distance_squared(), distfactor_to_bone(), distribute_grid(), blender::math::divide_ceil(), divide_ceil_u(), divide_ceil_ul(), divide_floor_i(), blender::color::ByteTraits::divide_round(), blender::color::FloatTraits::divide_round(), divide_round_i(), DNA_reconstruct_info_create(), DNA_reconstruct_info_free(), DNA_sdna_alias_data_ensure(), DNA_struct_get_compareflags(), DNA_struct_switch_endian(), blender::compositor::do_adjacentEdgeDetection(), blender::compositor::do_allEdgeDetection(), do_armature_box_select(), blender::compositor::do_createEdgeLocationBuffer(), do_cu_key(), blender::compositor::do_fillGradientBuffer(), do_key(), do_kink_spiral(), do_meta_box_select(), do_rel_cu_key(), do_versions_after_linking_280(), do_versions_mesh_mloopcol_swap_2_62_1(), blender::math::dominant_axis(), Dot(), dot(), btKrylovSolver< MatrixX >::dot(), blender::math::dot(), dot3(), Dot4(), dot_m3_v3_row_x(), dot_m3_v3_row_y(), dot_m3_v3_row_z(), dot_m4_v3_row_x(), dot_m4_v3_row_y(), dot_m4_v3_row_z(), dot_qtqt(), dot_shsh(), dot_v2v2(), dot_v2v2_db(), dot_v3db_v3fl(), dot_v3v3(), dot_v3v3_db(), dot_v3v3v3(), dot_v4v4(), dot_xy(), dotProduct(), btSoftBodyHelpers::Draw(), draw_disk_shaded(), draw_distortion(), draw_movieclip_cache(), draw_poly_v2i_n__span_y_sort(), draw_zebra_byte(), draw_zebra_float(), drawEdgeSlide(), libmv::DrawEllipse(), drawVertSlide(), drw_attributes_overlap(), DRW_cache_bone_dof_lines_get(), DRW_cache_bone_envelope_outline_get(), DRW_cache_bone_point_get(), DRW_cache_bone_point_wire_outline_get(), DRW_cache_bone_stick_get(), DRW_cache_camera_frame_get(), DRW_cache_camera_tria_wire_get(), DRW_cache_camera_volume_get(), DRW_cache_circle_get(), DRW_cache_field_cone_limit_get(), DRW_cache_field_tube_limit_get(), DRW_cache_field_vortex_get(), DRW_cache_light_area_square_lines_get(), DRW_cache_light_spot_lines_get(), DRW_cache_light_spot_volume_get(), DRW_cache_light_sun_lines_get(), DRW_cache_lightprobe_planar_get(), DRW_cache_particles_get_prim(), DRW_cache_quad_get(), DRW_cache_quad_wires_get(), DRW_cache_single_arrow_get(), drw_command_clear(), drw_mesh_weight_state_compare(), DRW_shgroup_clear_framebuffer(), dupliobject_cmp(), dupliobject_instancer_cmp(), dynamic_library_open_array_with_error(), ED_area_has_shared_border(), ed_curve_delete_selected(), ED_curve_join_objects_exec(), ED_curve_nurb_vert_selected_find(), ED_curve_select_swap(), ed_editnurb_extrude_flag(), ed_editnurb_spin(), ed_editnurb_translate_flag(), ED_lattice_flags_set(), ed_marker_move_apply(), ed_marker_move_init(), ED_mask_find_nearest_diff_point(), ed_mball_findnearest_metaelem(), ED_mesh_deform_bind_callback(), ED_mesh_join_objects_exec(), ED_mesh_mirrtopo_init(), ED_object_modifier_convert_psys_to_mesh(), ED_region_cache_draw_cached_segments(), ed_surf_delete_selected(), ED_transform_calc_gizmo_stats(), ED_transverts_create_from_obedit(), ED_transverts_update_obedit(), ED_view3d_minmax_verts(), edbm_extrude_repeat_exec(), edbm_loop_to_region_exec(), edge_isect_ls_sort_cb(), eevee_cryptomatte_sample_cmp_reverse(), eevee_object_key_cmp(), EIG_linear_solver_solve(), eigenvector(), elem_exists_impl(), elem_offset(), elem_streq(), encode_2f_to_float(), ensure_valid_reflection(), KDL::Equal(), Equal(), ImageLoader::equals(), Euler_richcmpr(), eulO_to_quat(), eval_fmodifier_influence(), evaluate_curve_type_object(), blender::bke::curves::catmull_rom::evaluate_segment(), blender::compositor::KeyingScreenOperation::execute_pixel(), blender::compositor::BrightnessOperation::execute_pixel_sampled(), execute_posetree(), KDL::exp(), blender::ed::outliner::TreeElementNLA::expand(), blender::ed::outliner::TreeElementNLATrack::expand(), GeometryExporter::export_key_mesh(), extract(), extract< 0 >(), extrapolate_points_by_length(), fabs(), facestep_sort(), fast_acosf(), fast_asinf(), fast_atan2f(), fast_atanf(), fast_erff(), fast_ierff(), fast_sinhf(), fcm_envelope_evaluate(), fcurve_eval_keyframes_interpolate(), blender::compositor::FHT(), blender::compositor::fht_convolve(), file_is_blend_backup(), filtered_incircle< double >(), filtered_orient2d< double >(), blender::ed::sculpt_paint::find_curves_brush_position(), find_first_points(), find_highest_panel(), blender::index_mask_ops::detail::find_indices_based_on_predicate__merge(), find_member_with_matching_name(), btLemkeAlgorithm::findLexicographicMinimum(), flerp(), blender::bke::float2_to_bool(), blender::bke::float2_to_byte_color(), blender::bke::float2_to_color(), blender::bke::float2_to_float(), blender::bke::float2_to_float3(), float2_to_float3(), blender::bke::float2_to_int(), blender::bke::float2_to_int8(), blender::bke::float3_to_bool(), blender::bke::float3_to_byte_color(), blender::bke::float3_to_color(), blender::bke::float3_to_float(), blender::bke::float3_to_float2(), float3_to_float4(), blender::bke::float3_to_int(), blender::bke::float3_to_int8(), float4_to_float3(), float_ramp_lookup(), blender::bke::float_to_bool(), blender::bke::float_to_byte_color(), blender::bke::float_to_color(), blender::bke::float_to_float2(), blender::bke::float_to_float3(), blender::bke::float_to_int(), blender::bke::float_to_int8(), floor(), blender::math::floor(), flushTransGraphData(), flushTransMasking(), flushTransSeq(), flushTransTracking(), flushTransUVs(), blender::nodes::node_fn_slice_string_cc::fn_node_slice_string_build_multi_function(), blender::nodes::node_fn_string_length_cc::fn_node_string_length_build_multi_function(), blender::nodes::node_fn_value_to_string_cc::fn_node_value_to_string_build_multi_function(), forward_diff_bezier_cotangent(), blender::math::fract(), fract(), fractf(), free_softbody_intern(), Freestyle_blendRamp(), libmv::FundamentalFrom7CorrespondencesLinear(), libmv::FundamentalToEssential(), gamtabs(), btLemkeAlgorithm::GaussJordanEliminationStep(), blender::compositor::GlareStreaksOperation::generate_glare(), blender::render::texturemargin::generate_margin(), geodesic_distance_propagate_across_triangle(), blender::io::obj::geometry_to_blender_objects(), BVHObjectBinning::get_bin(), get_first_selected_point(), blender::nodes::node_fn_boolean_math_cc::get_multi_function(), blender::nodes::get_multi_function(), blender::nodes::node_fn_float_to_int_cc::get_multi_function(), blender::nodes::node_fn_compare_cc::get_multi_function(), get_rgba(), blender::RandomNumberGenerator::get_unit_float2(), blender::RandomNumberGenerator::get_unit_float3(), Freestyle::WFace::getArea(), Freestyle::StrokeAttribute::getAttributeReal(), Freestyle::StrokeAttribute::getAttributeVec2f(), Freestyle::StrokeAttribute::getAttributeVec3f(), getBarycentric(), btSoftBodyHelpers::getBarycentricWeights(), EffectsExporter::getcol(), gjkepa2_impl::EPA::getedgedist(), EPA< btConvexTemplate >::getedgedist(), getJs(), getLowestRoot(), getSurroundingVerts(), getTransformOrientation_ex(), blender::nodes::geometry_nodes_eval_log::GFieldValueLog::GFieldValueLog(), ghashutil_bmelem_indexcmp(), ghashutil_tests_cmp_p(), ghost_event_proc(), GivensRotation::GivensRotation(), gpencil_add_arc_points(), gpencil_add_guide_points(), gpencil_bone_skinnable_cb(), gpencil_cb_cmp_frame(), gpencil_modifier_add_itemf(), gpencil_primitive_arc(), gpencil_primitive_bezier(), gpencil_primitive_circle(), gpencil_primitive_edit_event_handling(), gpencil_primitive_line(), gpencil_primitive_rectangle(), gpencil_primitive_rotate_line(), gpencil_smooth_buffer(), gpencil_stroke_from_buffer(), gpencil_tobject_dist_sort(), GPU_color_mask(), gpu_pbvh_format_equals(), gpu_select_buffer_depth_id_cmp(), GPU_vertbuf_attr_fill(), GPU_vertbuf_attr_fill_stride(), GPU_vertbuf_attr_get_raw_data(), GPU_vertbuf_attr_set(), GPU_vertbuf_raw_step(), GPU_vertbuf_raw_used(), GrahamScanConvexHull2D(), graph_disable_markers_exec(), graph_select_all_markers_exec(), greasepencil_blend_read_expand(), greasepencil_blend_read_lib(), group_copy_inputs(), group_copy_outputs(), group_gpu_copy_inputs(), group_gpu_move_outputs(), gts_vertex_principal_directions(), harmonic_coordinates_bind(), has_linked_ids_to_read(), hasedge(), blender::noise::hash(), blender::noise::hash_bit_final(), blender::noise::hash_bit_mix(), hash_uint(), hash_uint2(), hash_uint3(), hash_uint4(), heat_bone_weighting(), heat_calc_vnormals(), heat_laplacian_create(), heat_ray_tree_create(), hide_exec(), high(), hook_mod_itemf(), ibuftoimage(), id_order_compare(), idkey_cmp(), IDP_CopyArray(), idp_resize_group_array(), IDP_WriteArray(), IDP_WriteIDPArray(), iksolver_execute_tree(), image_cmp_frame(), image_foreach_cache(), image_invert_exec(), imagecache_hashcmp(), imagewraposa_aniso(), IMB_alpha_under_color_byte(), IMB_alpha_under_color_float(), IMB_dupImBuf(), imb_exr_multilayer_parse_channels_from_file(), imb_freemipmapImBuf(), IMB_get_size_in_memory(), imb_global_tile_cmp(), imb_half_x_no_alloc(), imb_half_y_no_alloc(), imb_load_jp2_stream(), imb_load_openexr(), IMB_loadiffname(), IMB_moviecache_get_cache_segments(), imb_thread_cache_init(), imb_thread_tile_cmp(), imb_tile_cache_exit(), IMB_tile_cache_params(), IMB_tiles_to_rect(), immAttr4ub(), immEndVertex(), immUniformColor3fvAlpha(), immUniformColor4f(), immUniformColor4ub(), immUniformThemeColorAlpha(), ImplicitSolve(), in_line< double >(), blender::incircle(), blender::incircle_fast(), btConvexHullInternal::Face::init(), init_editNurb_keyIndex(), blender::compositor::DirectionalBlurOperation::init_execution(), init_index_map(), init_kelvinlet_grab(), init_structDNA(), btDefaultSerializer::initDNA(), Initialize(), initialize_chain(), initialize_posetree(), btSoftBody::initializeDmInverse(), inputs_cmp(), insert(), insert_text_exec(), insert_vert_fcurve(), Freestyle::BlenderFileLoader::insertShapeNode(), blender::insphere(), blender::insphere_fast(), blender::bke::int8_to_bool(), blender::bke::int8_to_byte_color(), blender::bke::int8_to_color(), blender::bke::int8_to_float(), blender::bke::int8_to_float2(), blender::bke::int8_to_float3(), blender::bke::int8_to_int(), blender::bke::int_to_bool(), blender::bke::int_to_byte_color(), blender::bke::int_to_color(), blender::bke::int_to_float(), blender::bke::int_to_float2(), blender::bke::int_to_float3(), blender::bke::int_to_int8(), btDeformableMultiBodyDynamicsWorld::integrateTransforms(), internal_dependencies_panel_draw(), internalAdd(), interp(), interp_cubic_v3(), interp_qt_qtqt(), interp_v2_v2v2(), interp_v2_v2v2_db(), interp_v2_v2v2_flfl(), interp_v2_v2v2_slerp(), interp_v2_v2v2_slerp_safe(), interp_v2_v2v2v2(), interp_v3_v3v3(), interp_v3_v3v3_char(), interp_v3_v3v3_db(), interp_v3_v3v3_slerp(), interp_v3_v3v3_slerp_safe(), interp_v3_v3v3_uchar(), interp_v4_v4v4(), interp_v4_v4v4_char(), interp_v4_v4v4_uchar(), blender::float4x4::interpolate(), blender::math::interpolate(), interpolate_exciter(), interpolate_ies_vertical(), intersect(), intersections_compare(), blender::Set< Key, InlineBufferCapacity, ProbingStrategy, Hash, IsEqual, Slot, Allocator >::Intersects(), inv_slope(), inverse_lerp(), blender::fn::invert_boolean_field(), invert_m3_m3(), invert_m3_m3_ex(), InvLerp(), blender::math::is_any_zero(), is_array_equal(), is_cfra_eq(), is_cfra_lt(), blender::CPPType::is_equal(), blender::cpp_type_util::is_equal_cb(), is_poly_convex_v2(), is_quad_symmetric(), is_track_clean(), is_value_equal(), is_zero(), blender::math::is_zero(), Freestyle::StrokeAttribute::isAttributeAvailableReal(), Freestyle::StrokeAttribute::isAttributeAvailableVec2f(), Freestyle::StrokeAttribute::isAttributeAvailableVec3f(), isect_line_line_epsilon_v3(), isect_line_line_strict_v3(), isect_line_segment_tri_epsilon_v3(), isect_line_segment_tri_v3(), isect_line_sphere_v2(), isect_line_sphere_v3(), isect_point_tri_v2_int(), isect_ray_line_v3(), isect_ray_tri_epsilon_v3(), isect_ray_tri_v3(), isect_ray_tri_watertight_v3(), isect_sweeping_sphere_tri_v3(), isequal(), isNurbselU(), isNurbselUV(), isNurbselV(), join_mesh_single(), kdtree_cmp_bool(), kernel_ies_interp(), key_block_get_data(), keyblock_free_per_block_weights(), keycmp(), keyIndex_delNurb(), keyIndex_swap(), keyIndex_switchDirection(), knifeproject_poly_from_object(), laplacian_begin_solve(), laplacian_system_construct_end(), lattice_select_all_exec(), lattice_select_random_exec(), lattice_select_ungrouped_exec(), lattice_to_softbody(), layerEqual_mloopcol(), layerInterp_mcol(), layerInterp_mloopcol(), len(), len_manhattan_v2v2(), len_manhattan_v2v2_int(), len_manhattan_v3v3(), len_squared(), len_squared_v2v2(), len_squared_v2v2_db(), len_squared_v3v3(), len_squared_v4v4(), len_v3(), len_v3_db(), len_v3v3(), len_v4(), len_v4v4(), blender::math::length(), blender::math::length_manhattan(), blender::math::length_squared(), btSparseSdf< CELLSIZE >::Lerp(), lerp(), Lerp(), lib_weak_key_cmp(), libmv_byteBufferToFloatImage(), libmv_floatBufferToFloatImage(), libmv_floatImageToByteBuffer(), libmv_floatImageToFloatBuffer(), libmv_tracks_new(), KDL::LinComb(), KDL::LinCombR(), linear_grid_element_sub(), blender::bke::curves::bezier::linear_interpolation(), blender::geometry::linear_interpolation(), lineart_triangle_cull_single(), linestyle_blend_read_data(), linestyle_blend_read_expand(), linestyle_blend_read_lib(), linestyle_blend_write(), linestyle_copy_data(), KDL::log(), low(), madd(), madd4(), madd_v2_v2fl(), madd_v2_v2v2fl(), madd_v3_v3fl(), madd_v3_v3v3(), madd_v3_v3v3db_db(), madd_v3_v3v3fl(), madd_v3_v3v3v3(), madd_v3fl_v3fl_v3fl_v3i(), madd_v4_v4fl(), madd_v4_v4v4(), make_box_union(), make_child_duplis_faces_from_editmesh(), make_child_duplis_faces_from_mesh(), make_duplis_font(), make_duplis_particle_system(), make_float2(), make_float3(), make_float4(), make_float8_t(), make_int2(), make_int3(), make_int4(), make_links_data_exec(), make_local_exec(), make_orthonormals(), make_orthonormals_tangent(), make_projection(), make_selection_list_nurb(), make_structDNA(), make_transform(), make_uchar2(), make_uchar3(), make_uchar4(), make_uint2(), make_uint3(), make_uint4(), marker_block_handler(), mask(), mask_spline_feather_differentiated_points_with_resolution__double(), mask_spline_feather_differentiated_points_with_resolution__even(), masklay_shape_cmp_frame(), match_texture_space_exec(), MatchEdge(), blender::ui::ViewItemAPIWrapper::matches(), material_slot_de_select(), math_vector_add(), math_vector_max(), math_vector_mul(), math_vector_mul_strided(), math_vector_scale(), Matrix_richcmpr(), blender::color::ByteTraits::max(), blender::color::FloatTraits::max(), max(), blender::math::max(), KDL::max(), max4(), max_cc(), max_dd(), max_f(), max_ff(), max_fff(), max_ffff(), max_heuristic(), max_i(), max_ii(), max_iii(), max_iiii(), blender::math::max_inplace(), max_ulul(), max_uu(), max_v3_v3v3(), max_zz(), maxi(), med3(), MEM_guarded_printmemlist_stats(), MEM_size_safe_multiply(), merge(), mesh_calc_edges_mdata(), mesh_cd_layers_type_clear(), mesh_cd_layers_type_equal(), mesh_cd_layers_type_merge(), mesh_cd_layers_type_overlap(), mesh_faces_to_scratch(), mesh_get_x_mirror_faces(), mesh_nurbs_displist_to_mdata(), mesh_read_expand(), mesh_to_softbody(), meshdeform_add_intersections(), meshdeform_bind_floodfill(), meshdeform_boundary_total_weight(), meshdeform_check_semibound(), meshdeform_dynamic_bind(), meshdeform_interp_w(), meshdeform_matrix_add_cell(), meshdeform_matrix_add_exterior_phi(), meshdeform_matrix_add_rhs(), meshdeform_matrix_add_semibound_phi(), meshdeform_matrix_solve(), meshdeform_vert_task(), meshdeformModifier_do(), metaball_blend_read_expand(), metaball_blend_read_lib(), mf_ggx_transmission_albedo(), mid_v2_v2v2(), mid_v3_v3v3(), mid_v3_v3v3_angle_weighted(), blender::math::midpoint(), blender::color::ByteTraits::min(), blender::color::FloatTraits::min(), min(), blender::math::min(), KDL::min(), min4(), min_axis(), min_cc(), min_dd(), min_f(), min_ff(), min_fff(), min_ffff(), min_i(), min_ii(), min_iii(), min_iiii(), blender::math::min_inplace(), min_ulul(), min_uu(), min_zz(), mini(), mirror_facecmp(), mirror_facerotation(), mix(), blender::attribute_math::mix2(), mm256_sqrt(), blender::math::mod(), mod_inline(), modifier_add_itemf(), mouse_select_eval_buffer(), movemask(), moviecache_hashcmp(), msub(), Mul(), btConvexHullInternal::Int128::mul(), btConvexHullInternal::DMul< UWord, UHWord >::mul(), mul_qt_qtqt(), mul_v2_m3v3(), mul_v2_m3v3_center(), mul_v2_v2(), mul_v2_v2fl(), mul_v2_v2v2(), mul_v3_m3v3(), mul_v3_m3v3_db(), mul_v3_v3(), mul_v3_v3db_db(), mul_v3_v3fl(), mul_v4_v4(), mul_v4_v4fl(), btKrylovSolver< MatrixX >::multAndAdd(), btKrylovSolver< MatrixX >::multAndAddTo(), multibuf(), libmv::MultiplyElements(), multiresbake_check(), MyIntersect(), N4Step(), blender::ed::space_node::named_attribute_tooltip(), btDbvt::nearest(), nearest_cmp_dist(), nearZero(), negate_v2_v2(), negate_v3_v3(), negate_v4_v4(), btHullTriangle::neib(), blender::dot::UndirectedGraph::new_edge(), gjkepa2_impl::EPA::newface(), EPA< btConvexTemplate >::newface(), nlaevalchan_keycmp(), nmadd(), blender::nodes::node_geo_collection_info_cc::node_geo_exec(), node_instance_hash_key_cmp(), node_link_socket_match(), blender::ed::space_node::node_select_same_type_step_exec(), blender::ed::space_node::node_sort(), blender::nodes::NodeTreeRef::NodeTreeRef(), noise3_perlin(), btKrylovSolver< MatrixX >::norm(), normalEditModifier_do_radial(), normalize(), Normalize(), normalize_len(), normalize_v2_v2(), normalize_v2_v2_length(), normalize_v3_v3(), normalize_v3_v3_db(), normalize_v3_v3_length(), normalize_v3_v3_length_db(), ntreeShaderEndExecTree_internal(), ntreeTexEndExecTree_internal(), object_blend_read_data(), object_blend_read_expand(), object_blend_read_lib(), object_convert_exec(), object_defgroup_remove_edit_mode(), object_frame_has_keyframe(), object_mouse_select_menu(), object_rand_transverts(), object_select_all_by_material(), op_add(), op_div(), op_eq(), op_ge(), op_gt(), op_le(), op_lerp(), op_log2(), op_lt(), op_mul(), op_ne(), op_not(), op_smoothstep(), op_sub(), operator!(), operator!=(), blender::eevee::operator!=(), blender::fn::operator!=(), blender::gpu::operator!=(), blender::nodes::operator!=(), blender::operator!=(), operator&(), operator&=(), btBroadphasePairSortPredicate::operator()(), CONTACT_KEY_TOKEN_COMP::operator()(), GIM_RSORT_TOKEN_COMPARATOR::operator()(), btAngleCompareFunc::operator()(), btIntSortPredicate::operator()(), MyPairIndeSortPredicate::operator()(), GIM_HASH_NODE_GET_KEY::operator()(), uint_key_func::operator()(), GIM_HASH_NODE_CMP_MACRO::operator()(), integer_comparator::operator()(), btAlignedObjectArray< T >::less::operator()(), less_comparator::operator()(), GIM_HASH_NODE_CMP_KEY_MACRO::operator()(), blender::DefaultEquality::operator()(), EffectsExporter::operator()(), GeometryExporter::operator()(), ForEachMaterialFunctor< Functor >::operator()(), copy_elements_func::operator()(), memcopy_elements_func::operator()(), blender::tests::EqualityIntModN< N >::operator()(), operator*(), btConvexHullInternal::Int128::operator*(), operator*=(), operator+(), blender::operator+(), operator++(), operator+=(), operator-(), operator--(), operator-=(), operator/(), operator/=(), operator<(), blender::operator<(), operator<<(), operator<<=(), operator<=(), blender::operator<=(), avxi::operator=(), packed_float3::operator=(), blender::draw::Framebuffer::operator=(), blender::draw::Texture::operator=(), operator==(), blender::eevee::operator==(), blender::nodes::operator==(), blender::fn::operator==(), blender::gpu::operator==(), blender::tests::operator==(), blender::operator==(), operator>(), blender::operator>(), operator>=(), blender::operator>=(), operator>>(), KDL::operator>>(), operator>>=(), operator^(), blender::gpu::operator^(), operator^=(), operator|(), operator|=(), blender::gpu::operator~(), order_float2(), order_render_passes(), blender::orient2d(), blender::orient2d_fast(), blender::orient3d(), blender::orient3d_fast(), orth(), outerproduct(), outliner_add_bone(), outliner_add_id_contents(), outliner_add_object_contents(), outliner_but_identity_cmp_context_id_fn(), overlap_cmp(), OVERLAY_light_cache_populate(), p_chart_minimum_area_angle(), p_compare_geometric_uv(), p_face_stretch(), pack_data_in_mat4(), pack_fl_in_mat4(), paint_2d_lift_smear(), paint_2d_op(), particle_settings_blend_read_data(), particle_settings_blend_read_expand(), particle_settings_blend_read_lib(), particle_settings_blend_write(), particle_settings_copy_data(), particle_settings_free_data(), partition_nth_element(), pass_shgroup_dist_sort(), path_clear_remained(), path_clear_up_to(), path_test_extension(), pc_cmp(), blender::tests::perform_binary_operation(), permute(), pingpong(), pingpongf(), plane_marker_size_len_in_pixels(), PlaneTest(), pointcloud_blend_read_expand(), pointcloud_blend_read_lib(), pointer_unpack_from_uint(), pointOutsideOfPlane(), pointref_cmp_yx(), polarDecompose(), polarDecomposition(), popcnt(), posrandom(), KDL::posrandom(), postTrans(), KDL::pow(), pow20(), pow22(), power_heuristic(), power_heuristic_3(), precise_angle(), preprocess_include(), print_avxb(), print_avxi(), print_float2(), print_float3(), print_float4(), print_int3(), print_int4(), print_struct_sizes(), MD5Hash::process(), proj_paint_state_cavity_init(), proj_paint_state_screen_coords_init(), proj_paint_state_thread_init(), proj_paint_state_vert_flags_init(), project_image_refresh_tagged(), project_paint_end(), project_paint_op(), project_v3_v3(), projectFloatViewEx(), projection_to_transform(), projection_transpose(), ProjectOnAxis(), ProjectOnPlane(), gjkepa2_impl::GJK::projectorigin(), GJK< btConvexTemplate >::projectorigin(), ProjectOrigin(), pseudoInverse(), btSoftBody::PSolve_Anchors(), btSoftBody::PSolve_Links(), py_bl_math_lerp(), py_bl_math_smoothstep(), pygpu_state_color_mask_set(), pyrna_param_to_py(), pyrna_prop_compare(), pyrna_prop_richcmp(), pyrna_struct_compare(), pyrna_struct_richcmp(), KDL::PYTHAG(), qsort_str_cmp(), quad_4edge_subdivide(), QuadDice::quad_area(), quat_to_compatible_quat(), Quaternion_richcmpr(), random(), KDL::random(), ray_triangle_cross(), ray_triangle_dot(), ray_triangle_rcp(), btSoftBody::RayFromToCaster::rayFromToTriangle(), rayIntersectsTriangle(), rcp(), RE_bake_pixels_populate(), re_delaunay_triangulate(), read_library_clear_weak_links(), read_library_linked_ids(), recalcData_sequencer(), reconstruct_retrieve_libmv_tracks(), reconstruct_struct(), reconstruct_structs(), reconstructed_camera_index_get(), rect_clip(), redraw_timer_exec(), reduce_add(), reduce_and(), reduce_max(), reduce_min(), reduce_or(), reference_to_scratch(), btSoftBody::refine(), rel_flerp(), remove_non_constraint_edges_leave_valid_bmesh(), render_layer_add_pass(), render_result_exr_file_read_path(), replaceContactPoint(), Freestyle::Stroke::Resample(), libmv::reshape(), resolve_quad_u_v2(), resolve_quad_uv_v2_deriv(), resolve_tri_uv_v2(), return_editcurve_indexar(), return_editlattice_indexar(), reveal_exec(), rgb_ramp_lookup(), rgba_float_args_set(), rgba_uchar_args_set(), rgba_uchar_args_test_set(), rna_enum_bitmask(), rna_find_sdna_member(), rna_generate_struct_prototypes(), RNA_identifier_sanitize(), rna_is_collection_functions_struct(), rna_member_cmp(), rna_raw_access(), rna_sortlist(), rna_validate_identifier(), rotate(), rotate_indices(), rotateflagNurb(), round_box__edges(), round_box_shadow_edges(), round_db_to_char(), round_db_to_char_clamp(), round_db_to_int(), round_db_to_int_clamp(), round_db_to_short(), round_db_to_short_clamp(), round_db_to_uchar(), round_db_to_uchar_clamp(), round_db_to_uint(), round_db_to_uint_clamp(), round_db_to_ushort(), round_db_to_ushort_clamp(), round_fl_to_char(), round_fl_to_char_clamp(), round_fl_to_int(), round_fl_to_int_clamp(), round_fl_to_short(), round_fl_to_short_clamp(), round_fl_to_uchar(), round_fl_to_uchar_clamp(), round_fl_to_uint(), round_fl_to_uint_clamp(), round_fl_to_ushort(), round_fl_to_ushort_clamp(), round_v2i_v2fl(), RVAddBitmaps_float(), safe_acosf(), safe_asinf(), blender::math::safe_divide(), safe_divide(), safe_divide_color(), safe_divide_even_color(), safe_divide_float2_float(), safe_divide_shadow_catcher(), safe_inverse_sqrtf(), safe_invert_color(), safe_log(), safe_logf(), blender::math::safe_mod(), safe_modf(), safe_modulo(), safe_normalize(), safe_normalize_len(), safe_powf(), safe_sqrt(), safe_sqrtf(), Attribute::same_storage(), sameSign(), saturate(), saturatef(), sb_detect_aabb_collisionCached(), sb_detect_edge_collisionCached(), sb_detect_face_collisionCached(), sb_detect_face_pointCached(), sb_detect_vertex_collisionCached(), SB_estimate_transform(), ScaleAlongAxis(), scalenorm(), scalenormd(), scan_for_ext_face_forces(), scanfill(), sculpt_attribute_ref_equals(), sculpt_update_object(), SCULPT_vertcos_to_key(), select(), select_adjacent_cp(), select_editcurve_hook(), select_editlattice_hook(), select_linked_pick_invoke(), select_max(), select_min(), select_nth_bezt(), select_nth_bp(), select_row_exec(), select_similar_type_itemf(), selectend_nurb(), Freestyle::OGF::MatrixUtil::semi_definite_symmetric_eigen(), seq_cache_hashcmp(), seq_channel_cmp_fn(), seq_cmp_render_data(), seq_cmp_time_startdisp_channel(), seq_hash_render_data(), seq_sort_for_center_select(), seq_sort_for_depth_select(), seq_transform_collection_from_transdata(), set_alpha(), set_goal_weight_exec(), set_prop_dist(), set_radius_exec(), set_sign_bit(), set_subsurf_legacy_uv(), Freestyle::StrokeVertexRep::setAlpha(), Freestyle::FrsMaterial::setAmbient(), btSubSimplexClosestResult::setBarycentricCoordinates(), Freestyle::FrsMaterial::setDiffuse(), Freestyle::FrsMaterial::setEmission(), Freestyle::FrsMaterial::setLine(), Freestyle::Stroke::setMTex(), Freestyle::FrsMaterial::setSpecular(), blender::nodes::node_shader_clamp_cc::sh_node_clamp_build_multi_function(), Freestyle::StrokeShaders::BezierCurveShader::shade(), Freestyle::StrokeShaders::PolygonalizationShader::shade(), Freestyle::StrokeShaders::GuidingLinesShader::shade(), Freestyle::StrokeShaders::TipRemoverShader::shade(), shaderfx_add_itemf(), shadow_ray_smooth_surface_offset(), shape_itemf(), shape_preset_init_trias_ex(), shape_preset_trias_from_rect_checkmark(), shape_preset_trias_from_rect_menu(), shareedge(), shell_v2v2_mid_normalized_to_dist(), shell_v2v2_normalized_to_dist(), shell_v3v3_mid_normalized_to_dist(), shell_v3v3_normalized_to_dist(), btConvexHullInternal::shrink(), shuffle(), KDL::SIGN(), signum_enum(), signum_i(), signum_i_ex(), KDL::sin(), single_mat_users(), KDL::sinh(), site_lexicographic_sort(), size(), skin_choose_quad_bridge_order(), skin_output_connections(), slide_marker_modal(), smooth_exec(), smoothmin(), smoothminf(), Freestyle::Noise::smoothNoise2(), Freestyle::Noise::smoothNoise3(), snap(), snap_sel_to_grid_exec(), snap_selected_to_location(), snap_to_superellipsoid(), blender::ed::space_node::snode_autoconnect(), sobol_generate_direction_vectors(), softbody_apply_forces(), softbody_apply_goalsnap(), softbody_reset(), softbody_restore_prev_step(), softbody_to_object(), softbody_update_positions(), btLCP::solve1(), solve_cubic(), btSoftBody::solveConstraints(), libmv::SolveCubicPolynomial(), libmv::Dogleg< Function, Jacobian, Solver >::SolveDoglegDirection(), btLemkeSolver::solveMLCP(), SolveP2(), SolveP3(), SolveP4(), SolveP5(), SolveP5_1(), btReducedVector::sort(), blender::ed::space_node::sort_multi_input_socket_links(), sort_points_curvature(), blender::io::usd::USDStageReader::sort_readers(), sort_time_fcurve(), Freestyle::OGF::sphere_clip_vector(), Freestyle::SShape::SplitEdge(), spring_hairbend_estimate_dfdv(), spring_hairbend_estimate_dfdx(), springs_from_mesh(), sqr(), sqrt(), KDL::sqrt(), square_d(), square_f(), square_i(), square_s(), square_uchar(), square_uint(), btKrylovSolver< MatrixX >::squaredNorm(), sra(), srl(), stabilize_2d_remove_exec(), stabilize_2d_rotation_remove_exec(), stack_load_float(), stack_load_float3(), stack_load_float_default(), stack_load_int(), stack_load_int_default(), stack_store_float(), stack_store_float3(), stack_store_int(), stack_valid(), star_m3_v3(), stats_object_edit(), strhash_pair_cmp(), string_iequals(), blender::io::obj::strings_equal_after_first_lines(), Freestyle::Stroke::Stroke(), StrokeAttribute_get_attribute_real(), StrokeAttribute_get_attribute_vec2(), StrokeAttribute_get_attribute_vec3(), Freestyle::StrokeRep::StrokeRep(), studiolight_cmp(), studiolight_spherical_harmonics_geomerics_eval(), Sub(), btKrylovSolver< MatrixX >::sub(), sub_eul_euleul(), sub_qt_qtqt(), sub_v2_v2(), sub_v2_v2v2(), sub_v2_v2v2_db(), sub_v2_v2v2_int(), sub_v2db_v2fl_v2fl(), sub_v3_v3(), sub_v3_v3v3(), sub_v3_v3v3_db(), sub_v3_v3v3_int(), sub_v3db_v3fl_v3fl(), sub_v4_v4(), sub_v4_v4v4(), subd_triangle_attribute_float(), subd_triangle_attribute_float2(), subd_triangle_attribute_float3(), subd_triangle_attribute_float4(), subdividenurb(), svm_brightness_contrast(), svm_math(), svm_node_math(), svm_node_vector_math(), svm_vector_math(), blender::draw::Framebuffer::swap(), swap(), blender::draw::Texture::swap(), swap_v2_v2(), swap_v2_v2_db(), swap_v3_v3(), swap_v3_v3_db(), swap_v4_v4(), swap_v4_v4_db(), swapfunc(), switch_endian_keyblock(), switch_keys_direction(), switchdirection_knots(), symmetricSpatialOuterProduct(), btEigen::system(), KDL::tan(), KDL::tanh(), target_project_edge(), template_texture_select(), blender::tests::TEST(), TEST(), blender::fn::tests::TEST(), libmv::TEST(), blender::length_parameterize::tests::TEST(), blender::math::tests::TEST(), test_sin_cos_from_fraction_symmetry(), test_swap_v3_v3(), test_time_fcurve(), testhandles_fcurve(), testsort_array_str_cmp(), testsort_array_str_cmp_reverse(), testsort_listbase_str_cmp(), testsort_listbase_str_cmp_reverse(), tex_free_delegates(), tex_saw(), tex_sin(), tex_tri(), text_check_bracket(), text_check_delim(), text_convert_whitespace_exec(), text_line_break_exec(), texture_paint_camera_project_exec(), tile_sort_cb(), tilt_bezpart(), to_pixel_space(), tracking_get_keyframed_marker(), tracks_map_merge(), trackToTransData(), trans_data_compare_dist(), trans_data_compare_rdist(), transform_convert_mesh_mirrordata_calc(), transform_direction(), transform_direction_transposed(), transform_inverse_cross(), transform_inverse_dot(), transform_motion_array_interpolate(), transform_orientations_create_from_axis(), transform_perspective(), transform_perspective_direction(), transform_point(), tri_3edge_subdivide(), tri_to_quat(), tridiagonal_solve_with_limits(), blender::nodes::try_dispatch_float_math_fl3_fl3_fl3_to_fl3(), blender::nodes::try_dispatch_float_math_fl3_fl3_fl_to_fl3(), blender::nodes::try_dispatch_float_math_fl3_fl3_to_fl(), blender::nodes::try_dispatch_float_math_fl3_fl3_to_fl3(), blender::nodes::try_dispatch_float_math_fl3_fl_to_fl3(), blender::nodes::try_dispatch_float_math_fl_fl_fl_to_fl(), blender::nodes::try_dispatch_float_math_fl_fl_to_fl(), blender::nodes::try_dispatch_float_math_fl_to_fl(), tse_cmp(), txt_add_object(), txt_setcurr_tab_spaces(), UI_autocomplete_update_name(), ui_batch_roundbox_shadow_get(), ui_block_align_butal_cmp(), ui_but_rna_equals(), ui_but_v3_get(), ui_but_v3_set(), ui_def_but_rna__menu(), ui_do_but_COLORBAND(), ui_do_but_CURVE(), ui_draw_but_COLORBAND(), ui_draw_but_CURVE(), ui_draw_but_HSVCIRCLE(), ui_draw_but_TAB_outline(), ui_draw_gradient(), UI_GetThemeColorBlendShade4fv(), UI_GetThemeColorShade4fv(), UI_GetThemeColorShadeAlpha4fv(), UI_GetThemeColorShadeAlpha4ubv(), ui_icon_view_menu_cb(), ui_item_array(), blender::ed::space_node::ui_node_item_name_compare(), ui_numedit_but_CURVE(), ui_numedit_but_CURVEPROFILE(), ui_searchbox_event(), ui_searchbox_region_draw_cb__operator(), ui_searchbox_region_draw_fn(), ui_searchbox_region_free_fn(), ui_searchbox_update(), UI_view_item_matches(), ui_window_to_block_fl(), uiItemEnumR_string_prop(), uiItemFullR(), uint16_pack_to_uint(), uint_compare(), uniform_attr_list_cmp(), uniform_attr_sort_cmp(), unlink_material_fn(), unlink_texture_fn(), unpackhi(), unpacklo(), blender::gpu::GLVertArray::update_bindings(), blender::compositor::BrightnessOperation::update_memory_buffer_partial(), blender::compositor::KeyingScreenOperation::update_memory_buffer_partial(), IK_QSphericalSegment::UpdateAngle(), IK_QSwingSegment::UpdateAngle(), updateClosestVectorAndPoints(), btSoftBody::updateClusters(), btSoftBody::updateDeformation(), btSoftBody::updatePose(), util_image_multiply_native(), uv_edge_compare(), uv_select_linked_multi(), uvedit_uv_straighten_elements(), V2AddII(), V2Dot(), V2Length(), V2SquaredLength(), V2SubII(), v3d_editvertex_buts(), blender::gpu::vbo_bind(), vcloud_estimate_transform_v3(), vcol_to_fcol(), verg_radial(), VertDataAdd(), VertDataAvg4(), VertDataEqual(), VertDataSub(), VertexFormat_pack(), vgroup_assign_verts(), vgroup_itemf(), vgroup_select_verts(), vicon_colorset_draw(), view3d_boundbox_clip_m4(), view_angle_limits_apply_falloff(), view_angle_limits_init(), volume_blend_read_expand(), volume_blend_read_lib(), VolumeOf(), voronoi_checkCircle(), blender::noise::voronoi_distance(), voronoi_distance_1d(), voronoi_distance_2d(), voronoi_distance_3d(), voronoi_distance_4d(), voronoi_getEdgeIntersection(), voronoi_getXOfEdge(), VoronoiVertexWeight::VoronoiVertexWeight(), voxel_size_edit_draw(), vpaint_blend(), weightflagNurb(), widget_verts_to_triangle_strip(), wm_keymap_item_equals(), wm_keymap_item_equals_result(), wm_xr_navigation_teleport(), Camera::world_to_raster_size(), wrap_angle(), write_file_handle(), write_libraries(), blender::io::obj::MTLWriter::write_materials(), DeviceQueue::~DeviceQueue(), and GHOST_WindowCocoa::~GHOST_WindowCocoa().
|
static |
Definition at line 83 of file RandGen.cpp.
Referenced by _clamp(), _face_calcIFNo(), _glewStrCLen(), _softbody_calc_forces_slice_in_a_thread(), add_2nd_order_roller(), SVMCompiler::add_node(), add_this_collection(), blender::io::stl::STLMeshHelper::add_triangle(), btRigidBody::addConstraintRef(), adduplicateflagNurb(), angle_v2v2v2(), angle_v3v3v3(), annotation_smooth_buffer(), api_string(), btSoftBody::appendDeformableAnchor(), btSoftBody::appendNote(), applyAxisConstraintVec(), applyBakeTime(), applyBevelWeight(), applyBoneEnvelope(), applyBoneRoll(), btSoftBody::applyClusters(), applyCrease(), applyCurveShrinkFatten(), applyEdgeSlide(), applyGPOpacity(), applyGPShrinkFatten(), applyMaskShrinkFatten(), applyPushPull(), btSoftBody::applyRepulsionForce(), applyShear(), applyShrinkFatten(), applyTilt(), applyToSphere(), applyTrackball(), applyVertSlide(), arrayModifier_doArray(), atmosphere_intersection(), attr_align(), attr_create_generic(), balance_heuristic_3(), BaryCoord(), btSoftBody::BaryEval(), BaryEval(), batch_screen_edges_get(), Bend(), bezier_eq_continuous(), bezier_eq_noaccel_left(), bezier_eq_noaccel_right(), bezier_handle_calc_smooth_fcurve(), bezier_lock_unknown(), bezier_relax_direction(), bezier_restore_equation(), bisect_v3_v3v3v3(), BKE_gpencil_stroke_trim(), BKE_kelvinlet_grab(), BKE_kelvinlet_grab_biscale(), BKE_kelvinlet_grab_triscale(), BKE_mask_spline_resolution(), BKE_mesh_cmp(), BKE_mesh_merge_verts(), BKE_nurb_type_convert(), BKE_sim_debug_data_hash_combine(), blendfile_library_relocate_remap(), blf_font_count_missing_chars(), BLI_file_touch(), BLI_hash_int_2d(), BLI_hash_int_3d(), BLI_hash_md5_to_hexdigest(), BLI_hash_string(), BLI_path_filename_ensure(), BLI_path_frame_get(), BLI_path_frame_strip(), BLI_path_name_at_index(), BLI_scanfill_calc_ex(), BLI_str_escape(), BLI_str_partition_ex(), BLI_str_partition_ex_utf8(), BLI_str_unescape(), BLI_str_unescape_ex(), BLI_str_utf8_as_unicode(), BLI_str_utf8_as_unicode_step_or_error(), BLI_str_utf8_from_unicode(), BLI_str_utf8_from_unicode_len(), BLI_str_utf8_invalid_byte(), BLI_str_utf8_size(), BLI_str_utf8_size_safe(), BLI_strcasestr(), BLI_string_join_array(), BLI_string_join_array_by_sep_char(), BLI_string_join_array_by_sep_char_with_tableN(), BLI_string_join_array_by_sep_charN(), BLI_string_join_arrayN(), BLI_strncasestr(), BLI_tolower_ascii(), BLI_toupper_ascii(), BLI_tridiagonal_solve(), BLI_tridiagonal_solve_cyclic(), BLO_library_path_explode(), BMO_op_vinitf(), BPy_Chain_from_Chain(), brightcontrast_apply_threaded(), btDeformableRigidContactConstraint::btDeformableRigidContactConstraint(), btFsel(), btTripleCross(), blender::compositor::KeyingScreenOperation::build_voronoi_triangulation(), btSparseSdf< CELLSIZE >::BuildCell(), KKTPreconditioner::buildDiagonalS(), buttons_context_path_collection(), calc_cb_lgg(), calc_cb_sop(), btContinuousConvexCollision::calcTimeOfImpact(), btGjkConvexCast::calcTimeOfImpact(), btSubsimplexConvexCast::calcTimeOfImpact(), blender::bke::curves::catmull_rom::calculate_basis(), calculatePrincipalAxisTransform(), btMultiBodyDynamicsWorld::calculateSimulationIslands(), blender::nodes::node_shader_tex_noise_cc::NoiseFunction::call(), blender::nodes::node_shader_tex_white_noise_cc::WhiteNoiseFunction::call(), case_strhash(), ccl_try_align(), cg_filtered(), Chain_init(), btSoftBody::checkFace(), choose_api(), choose_winner(), circle_dashed_verts(), circle_verts(), Freestyle::BlenderFileLoader::clipLine(), closestPtPointTetrahedron(), closestPtPointTriangle(), cloth_calc_helper_forces(), collision_compute_barycentric(), color2uint(), color_balance_byte_byte(), color_balance_byte_float(), color_balance_float_float(), color_byte_to_float(), color_float4_to_uchar4(), color_float_to_byte(), color_linear_to_srgb(), color_linear_to_srgb_v3(), color_linear_to_srgb_v4(), color_sample_remove_cost(), color_scene_linear_to_srgb(), color_srgb_to_linear(), color_srgb_to_linear_v3(), color_srgb_to_linear_v4(), color_srgb_to_scene_linear(), color_uchar4_to_float4(), color_unpremultiply(), colorBalance_init_data(), colorband_init_from_table_rgba_resample(), combine_with_energy(), component(), libmv::euclidean_resection::ComputeBarycentricCoordinates(), libmv::euclidean_resection::ComputePointsCoordinatesInCameraFrame(), Freestyle::Controller::ComputeSteerableViewMap(), libmv::ComputeTrackingEquation(), continuousCollisionDetection(), PixelFormat::convert(), blender::compositor::ColorBalanceNode::convert_to_operations(), copy_attr_name(), cotangent_tri_weight_v3(), blender::nodes::node_geo_curve_primitive_arc_cc::create_arc_curve_from_points(), create_subd_mesh(), btMLCPSolver::createMLCP(), btMLCPSolver::createMLCPFast(), btMultiBodyMLCPConstraintSolver::createMLCPFastRigidBody(), cubic_interp(), cursor_buffer_set(), cursor_buffer_show(), btSoftBody::dampClusters(), dblSort3(), btMultiBodyDynamicsWorld::debugDrawWorld(), BlockATI1::decodeBlock(), BlockATI2::decodeBlock(), gjkepa2_impl::GJK::det(), GJK< btConvexTemplate >::det(), determinant_m2(), DNA_elem_array_size(), DNA_elem_id_match(), btSoftColliders::CollideSDF_RDF::DoNode(), btSoftColliders::CollideSDF_RS::DoNode(), btSoftColliders::CollideSDF_RD::DoNode(), libmv::DownsampleChannelsBy2(), btSoftBodyHelpers::Draw(), draw_culling_plane_test(), draw_disk_shaded(), draw_frustum_bound_sphere_calc(), drawBox(), drawVertex(), DRW_cache_light_spot_lines_get(), DRW_cache_light_spot_volume_get(), DRW_cache_light_sun_lines_get(), dynamic_paint_apply_surface_vpaint_cb(), ED_gpencil_trace_data_to_strokes(), edge_queue_tri_in_circle(), edge_queue_tri_in_sphere(), eigenvector(), encode_xml(), ensure_valid_reflection(), escape_uri_string(), escapePath(), libmv::euclidean_resection::EuclideanResectionEPnP(), libmv::euclidean_resection::EuclideanResectionPPnP(), btSparseSdf< CELLSIZE >::Evaluate(), blender::bke::curves::catmull_rom::evaluate_segment(), blender::compositor::KeyingScreenOperation::execute_pixel(), blender::compositor::SMAABlendingWeightCalculationOperation::execute_pixel(), blender::dot::Attributes::export__as_bracket_list(), exr_channels_in_multi_part_file(), exr_has_rgb(), filt_mitchell(), filtered_incircle< double >(), filtered_orient2d< double >(), iTaSC::Armature::finalize(), blender::StringRefBase::find(), blender::StringRefBase::find_first_not_of(), blender::StringRefBase::find_first_of(), blender::StringRefBase::find_last_not_of(), blender::StringRefBase::find_last_of(), FindIncidentEdge(), flatten_string_append(), form_factor_visible_quad(), fresnel_dielectric_cos(), btDbvtAabbMm::FromCE(), btDbvtAabbMm::FromCR(), fromFloat(), FrsCurve_init(), libmv::FundamentalFrom7CorrespondencesLinear(), gammaCorrect(), blender::compositor::GlareGhostOperation::generate_glare(), blender::compositor::GlareSimpleStarOperation::generate_glare(), btSoftBody::generateClusters(), BVHObjectBinning::get_bin(), get_limit_motor_info2(), blender::color::get_luminance(), getBarycentric(), btSoftBodyHelpers::getBarycentricWeights(), getInfo2NonVirtual(), getJs(), getLowestRoot(), getname_anim_fcurve(), GHOST_SystemPathsUnix::getUserSpecialDir(), gizmo2d_xform_invoke_prepare(), gpencil_calc_stroke_fill_uv(), gpencil_primitive_edit_event_handling(), gpencil_smooth_buffer(), gpencil_vfx_blur(), gpencil_vfx_glow(), gResolveSingleConstraintRowGeneric_scalar_reference(), gResolveSingleConstraintRowLowerLimit_scalar_reference(), gResolveSplitPenetrationImpulse_scalar_reference(), gResolveSplitPenetrationImpulse_sse2(), gts_vertex_principal_directions(), blender::noise::hash(), blender::noise::hash_bit_final(), blender::noise::hash_bit_mix(), hash_string(), blender::hash_string(), hash_uint(), hash_uint2(), hash_uint3(), hash_uint4(), headerRotation(), hue_correct_init_data(), idp_str_append_escape(), IMB_filter_extend(), in_line< double >(), blender::incircle(), blender::incircle_fast(), blender::robust_pred::incircleadapt(), btSymMatrix< T >::index(), ColorBlock::init(), btConvexHullInternal::Face::init(), init_fmatrix(), blender::compositor::FastGaussianBlurOperation::initialize_tile_data(), btSoftBody::initializeClusters(), btSoftBody::initializeDmInverse(), insert_into_textbuf(), blender::insphere(), blender::insphere_fast(), blender::robust_pred::insphereadapt(), blender::robust_pred::insphereexact(), btDeformableMultiBodyDynamicsWorld::integrateTransforms(), interp_v2_v2v2v2(), btMiniSDF::interpolate(), interpolate_ies_vertical(), intersect(), invGammaCorrect(), is_char_sep(), is_identifier(), is_name_legal(), blender::io::obj::is_whitespace(), isect_line_line_epsilon_v3(), isect_line_line_strict_v3(), isect_line_sphere_v2(), isect_line_sphere_v3(), isect_ray_line_v3(), isect_ray_ray_epsilon_v3(), isect_ray_tri_watertight_v3(), isect_seg_seg_v3(), isect_sweeping_sphere_tri_v3(), isZero(), kernel_ies_interp(), knife_sample_screen_density_from_closest_face(), libmv::KRt_From_P(), layerEqual_propcol(), lift_gamma_gain_to_asc_cdl(), ShaderManager::linear_rgb_to_gray(), linear_rgb_to_gray(), linearrgb_to_srgb(), lineart_bounding_area_edge_intersect(), lineart_create_render_buffer(), lineart_get_bounding_area(), lineart_intersection_mask_check(), lineart_intersection_priority_check(), lineart_point_inside_triangle(), lineart_point_triangle_relation(), lineart_usage_check(), BlenderImageLoader::load_pixels(), Freestyle::Canvas::loadMap(), loop_find_regions(), madd(), madd4(), madd_v3_v3v3v3(), madd_v3fl_v3fl_v3fl_v3i(), make_float8_t(), make_projection(), make_sep_waveform_view_from_ibuf_byte(), make_sep_waveform_view_from_ibuf_float(), make_transform(), makecubetable(), maskmodifier_apply_threaded(), math_matrix_jacobi_eigendecomposition(), MatrixToAxisAngle(), max4(), max_fff(), max_ffff(), max_iii(), max_iiii(), maxdirsterid(), mdisp_in_mdispquad(), med3(), memiter_words10k_test(), merge(), min4(), min_fff(), min_ffff(), min_iii(), min_iiii(), minmax_rgb(), msub(), mul_bfmatrix_lfvector(), btDeformableBackwardEulerObjective::multiply(), libmv::MultiplyElements(), N4Step(), gjkepa2_impl::EPA::newface(), EPA< btConvexTemplate >::newface(), nmadd(), blender::nodes::node_composite_channel_matte_cc::node_composit_init_channel_matte(), blender::nodes::node_composite_chroma_matte_cc::node_composit_init_chroma_matte(), blender::nodes::node_composite_color_matte_cc::node_composit_init_color_matte(), blender::nodes::node_composite_diff_matte_cc::node_composit_init_diff_matte(), blender::nodes::node_composite_distance_matte_cc::node_composit_init_distance_matte(), blender::nodes::node_composite_huecorrect_cc::node_composit_init_huecorrect(), blender::nodes::node_composite_luma_matte_cc::node_composit_init_luma_matte(), node_hash_int_str(), noise3_perlin(), normalEditModifier_do_radial(), nr_distance_to_edge(), ntreeCompositColorBalanceSyncFromCDL(), ntreeCompositColorBalanceSyncFromLGG(), oiio_load_pixels(), libmv::NumericJacobian< Function, mode >::operator()(), btSymMatrix< T >::operator()(), btMatrixX< T >::operator*(), operator*(), KDL::Rall1d< T, V, S >::operator=(), KDL::Rall2d< T, V, S >::operator=(), blender::orient2d(), blender::orient2d_fast(), blender::robust_pred::orient2dadapt(), blender::orient3d(), blender::orient3d_fast(), blender::robust_pred::orient3dadapt(), OVERLAY_light_cache_populate(), p_abf_matrix_invert(), p_face_stretch(), pack_data_in_mat4(), Mesh::pack_patches(), libmv::PearsonProductMomentCorrelation(), pointOutsideOfPlane(), polygonize(), power_heuristic_3(), btSoftBody::predictMotion(), libmv::PrintArray(), btSoftColliders::CollideVF_SS::Process(), btSoftColliders::CollideVF_DD::Process(), btSoftColliders::CollideCCD::Process(), MD5Hash::process(), libmv::Project(), iTaSC::project(), gjkepa2_impl::GJK::projectorigin(), GJK< btConvexTemplate >::projectorigin(), ProjectOrigin(), btSoftBody::PSolve_RContacts(), btSoftBody::PSolve_SContacts(), pygpu_texture_clear(), pyrna_prop_str(), QuadDice::quad_area(), KDL::Rall1d< T, V, S >::Rall1d(), KDL::Rall2d< T, V, S >::Rall2d(), btSoftBody::RayFromToCaster::rayFromToTriangle(), re_delaunay_triangulate(), IMemStream::read(), IMMapStream::read(), IFileStream::read(), blender::io::obj::read_next_line(), ShaderManager::rec709_to_scene_linear(), btSoftBody::releaseCluster(), btSoftBody::removeAnchor(), btRigidBody::removeConstraintRef(), btSoftColliders::CollideFF_DD::Repel(), btSoftColliders::CollideCCD::Repel(), resolve_tri_uv_v2(), resolveSingleConstraintRowGeneric(), resolveSingleConstraintRowGenericSIMD(), resolveSingleConstraintRowLowerLimit(), resolveSingleConstraintRowLowerLimitSIMD(), blender::StringRefBase::rfind(), rgb_to_hsv(), RNA_struct_bl_idname_ok_or_report(), BVHBuild::rotate(), rotate_indices(), rotate_point_v2(), libmv::RotationAroundX(), libmv::RotationAroundY(), libmv::RotationAroundZ(), RVAddBitmaps_float(), libmv::SamplePattern(), libmv::SamplePlanarPatch(), Freestyle::SteerableViewMap::saveSteerableViewMap(), blender::robust_pred::scale_expansion_zeroelim(), scopes_update_cb(), scopes_update_reduce(), libmv::euclidean_resection::SelectControlPoints(), seq_convert_transform_crop(), seq_convert_transform_crop_2(), sequencer_image_crop_init(), set_subsurf_legacy_uv(), btSubSimplexClosestResult::setBarycentricCoordinates(), setcorner(), GHOST_SystemWayland::setCursorShape(), shadow_ray_smooth_surface_offset(), shortestArcQuat(), btConvexHullInternal::shrink(), slide_point_modal(), smoothmin(), smoothminf(), Freestyle::Noise::smoothNoise3(), snap_to_superellipsoid(), solve_cubic(), libmv::SolveCubicPolynomial(), libmv::Dogleg< Function, Jacobian, Solver >::SolveDoglegDirection(), btMultiBodyMLCPConstraintSolver::solveGroupCacheFriendlyIterations(), btMLCPSolver::solveGroupCacheFriendlyIterations(), SolveP3(), SolveP4(), SolveP4De(), SolveP5(), SolveP5_1(), solveSingleIteration(), Freestyle::OGF::sphere_clip_vector(), srgb_to_linearrgb(), str_ghash_tests(), string_to_lower(), btKrylovSolver< MatrixX >::sub(), subd_triangle_attribute_float(), subd_triangle_attribute_float2(), subd_triangle_attribute_float3(), subd_triangle_attribute_float4(), subd_triangle_patch_corners(), surface_intersection(), KDL::svd_eigen_HH(), svd_m4(), svm_math(), svm_node_math(), svm_node_vector_math(), svm_node_wavelength(), svm_vector_math(), ColorBlock::swizzle(), btEigen::system(), target_project_edge(), Freestyle::StrokeTesselator::Tesselate(), Freestyle::ViewMapTesselator::Tesselate(), blender::tests::TEST(), TEST(), blender::math::tests::TEST(), test_line_start(), text_font_draw_character(), text_font_draw_character_utf8(), toFloat(), transform_direction(), transform_image(), transform_perspective(), transform_perspective_direction(), transform_point(), transform_rotate(), blender::ed::outliner::TreeElementRNAArrayElement::TreeElementRNAArrayElement(), tri_to_quat(), tridiagonal_solve_with_limits(), blender::nodes::try_dispatch_float_math_fl3_fl3_fl3_to_fl3(), blender::nodes::try_dispatch_float_math_fl3_fl3_fl_to_fl3(), blender::nodes::try_dispatch_float_math_fl_fl_fl_to_fl(), txt_backspace_char(), txt_delete_char(), txtfmt_py_numeral_char_is_binary(), txtfmt_py_numeral_char_is_decimal(), txtfmt_py_numeral_char_is_hexadecimal(), txtfmt_py_numeral_char_is_octal(), txtfmt_py_numeral_char_is_zero(), ui_batch_roundbox_shadow_get(), UI_text_clip_middle_ex(), ui_window_to_block_fl(), blender::bke::cryptomatte::manifest::unquote_(), blender::compositor::KeyingScreenOperation::update_memory_buffer_partial(), blender::compositor::SMAABlendingWeightCalculationOperation::update_memory_buffer_partial(), blender::compositor::FastGaussianBlurOperation::update_memory_buffer_started(), updateClosestVectorAndPoints(), btSoftBody::updateClusters(), btSoftBody::updateDeformation(), utf8_as_char32(), V2Add(), V2AddII(), V2SubII(), v3d_editvertex_buts(), VertDataAvg4(), vicon_colorset_draw(), VolumeOf(), voronoi_checkCircle(), voronoi_getXOfEdge(), VoronoiVertexWeight::VoronoiVertexWeight(), wavelength_to_xyz(), window_display_text(), wm_event_add_ghostevent(), wm_xr_session_controller_data_free(), Camera::world_to_raster_size(), OMemStream::write(), OFileStream::write(), and writeBackSolverBodyToMultiBody().
|
extern |
|
static |
Definition at line 1534 of file ViewMapBuilder.cpp.
Referenced by Freestyle::ViewMapBuilder::ComputeFastRayCastingVisibility(), Freestyle::ViewMapBuilder::ComputeRayCastingVisibility(), Freestyle::ViewMapBuilder::ComputeSweepLineIntersections(), and Freestyle::ViewMapBuilder::ComputeVeryFastRayCastingVisibility().
|
static |
Definition at line 1535 of file ViewMapBuilder.cpp.
Referenced by Freestyle::ViewMapBuilder::ComputeFastRayCastingVisibility(), Freestyle::ViewMapBuilder::ComputeRayCastingVisibility(), Freestyle::ViewMapBuilder::ComputeSweepLineIntersections(), and Freestyle::ViewMapBuilder::ComputeVeryFastRayCastingVisibility().
|
static |
Definition at line 15 of file Precision.h.
Referenced by Freestyle::CurveInternal::__point_iterator< Traits >::begin(), ComputeCenterTangent(), Freestyle::Smoother::computeCurvature(), Freestyle::CurveInternal::__point_iterator< Traits >::decrement(), Freestyle::CurveInternal::CurvePointIterator::decrement(), Freestyle::CurveInternal::__point_iterator< Traits >::increment(), Freestyle::CurveInternal::CurvePointIterator::increment(), Freestyle::GeomUtils::intersect2dLine2dLine(), Freestyle::GeomUtils::intersect2dSeg2dSeg(), Freestyle::GeomUtils::intersect2dSegPoly(), Freestyle::CurveInternal::CurvePointIterator::isBegin(), LanczosWindowed(), Freestyle::Operators::recursiveSplit(), Freestyle::Operators::reset(), Freestyle::Operators::sequentialSplit(), Freestyle::StrokeShaders::BezierCurveShader::shade(), and Freestyle::Smoother::Smoother().
|
static |
Definition at line 52 of file SceneHash.cpp.
|
static |
Definition at line 74 of file AdvancedStrokeShaders.cpp.
Referenced by Freestyle::SpatialNoiseShader::shade(), and Freestyle::SpatialNoiseShader::SpatialNoiseShader().
|
static |
Definition at line 73 of file RandGen.cpp.
Referenced by Freestyle::BoxGrid::assignCells(), Freestyle::SphericalGrid::assignCells(), Freestyle::GaussianPyramid::BuildPyramid(), Freestyle::Controller::ComputeSteerableViewMap(), computeVisibility(), ContextFunctions_read_complete_view_map_pixel(), ContextFunctions_read_directional_view_map_pixel(), ContextFunctions_read_map_pixel(), Freestyle::StrokeShaders::CurvePiece::CurvePiece(), Freestyle::Controller::displayDensityCurves(), Freestyle::RandGen::drand48(), edgeStopping(), Freestyle::BoxGrid::findCell(), Freestyle::SphericalGrid::findCell(), FrsNoise_turbulence_smooth(), Freestyle::RGBImage::getB(), Freestyle::ViewMap::getClosestFEdge(), Freestyle::ViewMap::getClosestViewEdge(), Freestyle::CurvePoint::getFEdge(), Freestyle::RGBImage::getG(), Freestyle::RGBImage::getR(), Freestyle::GaussianFilter::getSmoothedPixel(), Freestyle::Grid::insertOccluder(), Interface0D_projected_x_get(), Freestyle::PseudoNoise::linearNoise(), Freestyle::OGF::ogf_swap(), Freestyle::Predicates1D::WithinImageBoundaryUP1D::operator()(), Freestyle::less_Intersection::operator()(), Freestyle::less_SVertex2D::operator()(), Freestyle::RGBImage::pixel(), Freestyle::GrayImage::pixel(), Freestyle::AppView::rabs(), Freestyle::AppCanvas::readColorPixels(), Freestyle::SteerableViewMap::readCompleteViewMapPixel(), Freestyle::ContextFunctions::ReadCompleteViewMapPixelCF(), Freestyle::AppCanvas::readDepthPixels(), Freestyle::ContextFunctions::ReadDirectionalViewMapPixelCF(), Freestyle::ContextFunctions::ReadMapPixelCF(), Freestyle::SteerableViewMap::readSteerableViewMapPixel(), Freestyle::NodeTransform::Rotate(), Freestyle::SteerableViewMap::saveSteerableViewMap(), Freestyle::NodeTransform::Scale(), Freestyle::OGF::MatrixUtil::semi_definite_symmetric_eigen(), Freestyle::GrayImage::setArray(), Freestyle::RGBImage::setArray(), Freestyle::Stroke::setBeginningOrientation(), Freestyle::Stroke::setEndingOrientation(), Freestyle::RGBImage::setPixel(), Freestyle::GrayImage::setPixel(), Freestyle::StrokeShaders::BackboneStretcherShader::shade(), Freestyle::PseudoNoise::smoothNoise(), Freestyle::StrokeShaders::CurvePiece::subdivide(), Freestyle::NodeTransform::Translate(), Freestyle::PseudoNoise::turbulenceLinear(), Freestyle::PseudoNoise::turbulenceSmooth(), ViewMap_get_closest_fedge(), and ViewMap_get_closest_viewedge().