Searched refs:tol (Results 1 - 25 of 35) sorted by relevance

12

/inkscape/src/libcola/
H A Dconjugate_gradient.h15 double tol,
21 unsigned n, double tol,
H A Dconjugate_gradient.cpp58 double tol,
70 conjugate_gradient(vA,vx,vb,n,tol,max_iterations);
79 unsigned n, double tol,
86 tol *= tol;
87 while(k < max_iterations && r_r > tol) {
54 conjugate_gradient(double **A, double *x, double *b, unsigned n, double tol, unsigned max_iterations) argument
76 conjugate_gradient(valarray<double> const &A, valarray<double> &x, valarray<double> const &b, unsigned n, double tol, unsigned max_iterations) argument
H A Dcola.cpp31 tol(0.0001),
143 conjugate_gradient(lap2, coords, b, n, tol, n);
311 GradientProjection gp(dim,n,Q,coords,tol,100,
348 gpX = new GradientProjection(HORIZONTAL,n,Q,X,tol,100,acsx,avoidOverlaps,boundingBoxes,pbcx,scx);
349 gpY = new GradientProjection(VERTICAL,n,Q,Y,tol,100,acsy,avoidOverlaps,boundingBoxes,pbcy,scy);
/inkscape/src/2geom/
H A Dsbasis-geometric.h53 cutAtRoots(Piecewise<D2<SBasis> > const &M, double tol=1e-4);
57 double tol=.01, unsigned order=3);
61 double tol=.01, unsigned order=3);
65 double tol=.01, unsigned order=3);
69 double tol=.01, unsigned order=3);
73 double tol=.01, unsigned order=3);
76 double tol=.01, unsigned order=3);
80 // double tol=.1);
82 Piecewise<SBasis> curvature( D2<SBasis> const &M, double tol=.01);
83 Piecewise<SBasis> curvature(Piecewise<D2<SBasis> > const &M, double tol
[all...]
H A Dsbasis-math.h35 //TODO: in all these functions, compute 'order' according to 'tol'.
66 Piecewise<SBasis> sqrt( SBasis const &f, double tol=1e-3, int order=3);
67 Piecewise<SBasis> sqrt(Piecewise<SBasis>const &f, double tol=1e-3, int order=3);
70 Piecewise<SBasis> cos( SBasis const &f, double tol=1e-3, int order=3);
71 Piecewise<SBasis> cos(Piecewise<SBasis> const &f, double tol=1e-3, int order=3);
72 Piecewise<SBasis> sin( SBasis const &f, double tol=1e-3, int order=3);
73 Piecewise<SBasis> sin(Piecewise<SBasis> const &f, double tol=1e-3, int order=3);
75 Piecewise<SBasis> log( SBasis const &f, double tol=1e-3, int order=3);
76 Piecewise<SBasis> log(Piecewise<SBasis>const &f, double tol=1e-3, int order=3);
80 Piecewise<SBasis> reciprocalOnDomain(Interval range, double tol
[all...]
H A Dsbasis-math.cpp35 //TODO: in all these functions, compute 'order' according to 'tol'.
139 double tol,
145 if (f.at0()<-tol*tol && f.at1()<-tol*tol){
146 return sqrt_internal(-f,tol,order);
147 }else if (f.at0()>tol*tol && f.at1()>tol*to
138 sqrt_internal(SBasis const &f, double tol, int order) argument
181 sqrt(SBasis const &f, double tol, int order) argument
188 sqrt(Piecewise<SBasis> const &f, double tol, int order) argument
209 sin( SBasis const &f, double tol, int order) argument
215 sin(Piecewise<SBasis> const &f, double tol, int order) argument
222 cos(Piecewise<SBasis> const &f, double tol, int order) argument
237 cos( SBasis const &f, double tol, int order) argument
282 reciprocalOnDomain(Interval range, double tol) argument
329 reciprocal(SBasis const &f, double tol, int order) argument
335 reciprocal(Piecewise<SBasis> const &f, double tol, int order) argument
[all...]
H A Dsbasis-to-bezier.h53 void build_from_sbasis(PathBuilder &pb, D2<SBasis> const &B, double tol, bool only_cubicbeziers);
69 PathVector path_from_piecewise(Piecewise<D2<SBasis> > const &B, double tol, bool only_cubicbeziers = false);
71 Path path_from_sbasis(D2<SBasis> const &B, double tol, bool only_cubicbeziers = false);
72 inline Path cubicbezierpath_from_sbasis(D2<SBasis> const &B, double tol) argument
73 { return path_from_sbasis(B, tol, true); }
H A Dsbasis-geometric.cpp31 * Return a list of doubles that appear in both a and b to within error tol
33 * tol tolerance
36 vect_intersect(vector<double> const &a, vector<double> const &b, double tol=0.){ argument
40 if (fabs(a[i]-b[j])<tol){
152 \param tol the maximum error allowed.
157 Geom::atan2(Piecewise<D2<SBasis> > const &vect, double tol, unsigned order){ argument
159 Piecewise<D2<SBasis> > v = cutAtRoots(vect,tol);
166 angle = divide (x*derivative(y)-y*derivative(x), x*x+y*y, tol, order);
183 \param tol the maximum error allowed.
188 Geom::atan2(D2<SBasis> const &vect, double tol, unsigne argument
199 tan2(SBasis const &angle, double tol, unsigned order) argument
210 tan2(Piecewise<SBasis> const &angle, double tol, unsigned order) argument
225 unitVector(D2<SBasis> const &V_in, double tol, unsigned order) argument
305 unitVector(Piecewise<D2<SBasis> > const &V, double tol, unsigned order) argument
324 arcLengthSb(Piecewise<D2<SBasis> > const &M, double tol) argument
338 arcLengthSb(D2<SBasis> const &M, double tol) argument
364 curvature(D2<SBasis> const &M, double tol) argument
380 curvature(Piecewise<D2<SBasis> > const &V, double tol) argument
402 arc_length_parametrization(D2<SBasis> const &M, unsigned order, double tol) argument
434 arc_length_parametrization(Piecewise<D2<SBasis> > const &M, unsigned order, double tol) argument
458 length_integrating(D2<SBasis> const &B, double &result, double &abs_error, double tol) argument
484 length(D2<SBasis> const &s, double tol) argument
498 length(Piecewise<D2<SBasis> > const &s, double tol) argument
[all...]
H A Dpiecewise.cpp49 divide(Piecewise<SBasis> const &a, Piecewise<SBasis> const &b, double tol, unsigned k, double zero) { argument
54 Piecewise<SBasis> divi = divide(pa[i], pb[i], tol, k, zero);
60 Piecewise<SBasis> divide(Piecewise<SBasis> const &a, SBasis const &b, double tol, unsigned k, double zero){ argument
61 return divide(a,Piecewise<SBasis>(b),tol,k,zero);
63 Piecewise<SBasis> divide(SBasis const &a, Piecewise<SBasis> const &b, double tol, unsigned k, double zero){ argument
64 return divide(Piecewise<SBasis>(a),b,tol,k,zero);
66 Piecewise<SBasis> divide(SBasis const &a, SBasis const &b, double tol, unsigned k, double zero) { argument
75 //TODO: what is a good relative tol? atm, c=a/b +/- (tol/a)%...
88 if (r.tailError(k)<tol) retur
231 level_set(Piecewise<SBasis> const &f, Interval const &level, double tol) argument
250 level_set(Piecewise<SBasis> const &f, double v, double vtol, double tol) argument
[all...]
H A Dd2-sbasis.cpp168 //if tol>0, only force continuity where the jump is smaller than tol.
169 Piecewise<D2<SBasis> > force_continuity(Piecewise<D2<SBasis> > const &f, double tol, bool closed) argument
178 if (tol<=0 || L2sq(pt0-pt1)<tol*tol){
202 split_at_discontinuities (Geom::Piecewise<Geom::D2<Geom::SBasis> > const & pwsbin, double tol) argument
208 if (i==(pwsbin.segs.size()-1) || L2(pwsbin.segs[i].at1()- pwsbin.segs[i+1].at0()) > tol){
254 std::vector<Piecewise<D2<SBasis> > > fuse_nearby_ends(std::vector<Piecewise<D2<SBasis> > > const &f, double tol){ argument
266 if ( L2(a-aj) < tol ) {
322 level_set( D2<SBasis> const &f, Point p, double tol) argument
342 level_sets( D2<SBasis> const &f, std::vector<Point> pts, double tol) argument
[all...]
H A Dsbasis-to-bezier.cpp425 * tolerance tol $= e*A^k$ and invert getting $A = e^{1/k}$ and $a = 1/2 - \sqrt{1/4 - A}$
428 subpath_from_sbasis_incremental(Geom::OldPathSetBuilder &pb, D2<SBasis> B, double tol, bool initial) {
434 //std::cout << "tol = " << tol << std::endl;
436 double A = std::sqrt(tol/te); // pow(te, 1./k)
474 void build_from_sbasis(Geom::PathBuilder &pb, D2<SBasis> const &B, double tol, bool only_cubicbeziers) { argument
478 if(tail_error(B, 3) < tol || sbasis_size(B) == 2) { // nearly cubic enough
488 build_from_sbasis(pb, compose(B, Linear(0, 0.5)), tol, only_cubicbeziers);
489 build_from_sbasis(pb, compose(B, Linear(0.5, 1)), tol, only_cubicbeziers);
500 path_from_sbasis(D2<SBasis> const &B, double tol, boo argument
516 path_from_piecewise(Geom::Piecewise<Geom::D2<Geom::SBasis> > const &B, double tol, bool only_cubicbeziers) argument
[all...]
H A Dsbasis-roots.cpp205 static int upper_level(vector<double> const &levels,double x,double tol=0.){ argument
206 return(upper_bound(levels.begin(),levels.end(),x-tol)-levels.begin());
255 //TODO: use different tol for t and f ?
300 //hum, rounding errors frighten me! so I add this +tol...
374 static std::vector<Interval> fuseContiguous(std::vector<Interval> const &sets, double tol=0.){ argument
379 if ( result.back().max() + tol >= sets[i].min() ){
415 double tol=1e-5){
504 if ( t1 - t0 <= tol ){
520 //To make sure we finally exit the level jump at least by tol:
521 t0 = std::min( std::max( t0, a + tol ),
407 level_sets_internal(SBasis const &f, SBasis const &df, std::vector<Interval> const &levels, std::vector<std::vector<Interval> > &solsets, double a, double fa, double b, double fb, double tol=1e-5) argument
530 level_sets(SBasis const &f, std::vector<Interval> const &levels, double a, double b, double tol) argument
547 level_set(SBasis const &f, double level, double vtol, double a, double b, double tol) argument
551 level_set(SBasis const &f, Interval const &level, double a, double b, double tol) argument
555 level_sets(SBasis const &f, std::vector<double> const &levels, double vtol, double a, double b, double tol) argument
[all...]
H A Dtoposweep.cpp78 assert(are_near(e.section->fp, vertices[i].avg, tol) || are_near(e.section->tp, vertices[i].avg, tol));
79 assert(!are_near(e.section->fp, e.section->tp, tol));
149 if(are_near(ap[dim], bp[dim], tol)) {
168 //TODO: should we use tol in these conditions?
174 if(are_near(a.fp[1-dim], b.fp[1-dim], tol)) {
223 unsigned find_vertex(std::vector<TopoGraph::Vertex> const &vertices, Point p, double tol) { argument
225 if(are_near(vertices[i].avg, p, tol)) return i;
345 TopoGraph::TopoGraph(PathVector const &ps, Dim2 d, double t) : dim(d), tol(t) {
347 ContextAdapter<DerefAdapter<SectionSorter> > s_sort = DerefAdapter<SectionSorter>(SectionSorter(ps, (Dim2)(1-d), tol));
[all...]
H A Dsbasis.h390 \param tol largest abs val considered 0
395 valuation(SBasis const &a, double tol=0){
398 fabs(a[val][0])<tol &&
399 fabs(a[val][1])<tol )
410 SBasis compose_inverse(SBasis const &f, SBasis const &g, unsigned order=2, double tol=1e-3);
459 * is returned (with a precision tol on the boundaries).
464 \param tol: tolerance on the result bounds.
472 double tol = 1e-5);
479 \param tol: tolerance on the bounds of the result.
486 double tol
[all...]
H A Dtoposweep.h87 // Represents an e double tol;dge on a vertex
97 // edges have an endpoint tol away.
129 double tol; member in class:Geom::TopoGraph
136 //TopoGraph sweep_graph(PathVector const &ps, Dim2 d = X, double tol = 0.00001);
151 double tol; member in class:Geom::SectionSorter
158 SectionSorter(const PathVector &rs, Dim2 d, double t = 0.00001) : ps(rs), dim(d), tol(t) {}
H A Dconcepts.h151 double tol; member in struct:Geom::NearConcept
154 res = are_near(a, b, tol);
H A Dd2.h191 are_near(D2<T> const &a, D2<T> const &b, double tol) { argument
193 return are_near(a[0], b[0], tol) && are_near(a[1], b[1], tol);
516 Piecewise<D2<SBasis> > force_continuity(Piecewise<D2<SBasis> > const &f, double tol=0, bool closed=false);
518 std::vector<Piecewise<D2<SBasis> > > fuse_nearby_ends(std::vector<Piecewise<D2<SBasis> > > const &f, double tol=0);
520 std::vector<Geom::Piecewise<Geom::D2<Geom::SBasis> > > split_at_discontinuities (Geom::Piecewise<Geom::D2<Geom::SBasis> > const & pwsbin, double tol = .0001);
547 std::vector<Interval> level_set( D2<SBasis> const &f, Point p, double tol);
549 std::vector<std::vector<Interval> > level_sets( D2<SBasis> const &f, std::vector<Point> pts, double tol);
H A Dpolynomial.h203 Poly gcd(Poly const &a, Poly const &b, const double tol=1e-10);
218 double polish_root(Poly const & p, double guess, double tol);
H A Dpiecewise.h468 Piecewise<T> remove_short_cuts(Piecewise<T> const &f, double tol) {
474 if (f.cuts[i+1]-f.cuts[i] >= tol || i==f.size()-1) {
488 Piecewise<T> remove_short_cuts_extending(Piecewise<T> const &f, double tol) {
495 if (f.cuts[i+1]-f.cuts[i] >= tol) {
740 //TODO: replace divide(a,b,k) by divide(a,b,tol,k)?
741 //TODO: atm, relative error is ~(tol/a)%. Find a way to make it independant of a.
744 divide(Piecewise<SBasis> const &a, Piecewise<SBasis> const &b, double tol, unsigned k, double zero=1.e-3);
746 divide(SBasis const &a, Piecewise<SBasis> const &b, double tol, unsigned k, double zero=1.e-3);
748 divide(Piecewise<SBasis> const &a, SBasis const &b, double tol, unsigned k, double zero=1.e-3);
750 divide(SBasis const &a, SBasis const &b, double tol, unsigne
[all...]
/inkscape/src/live_effects/
H A Dlpe-powerstroke.cpp101 static Circle touching_circle( D2<SBasis> const &curve, double t, double tol=0.01 )
103 //Piecewise<SBasis> k = curvature(curve, tol);
114 Piecewise<D2<SBasis> > unitv = unitVector(dM,tol);
117 k = divide(k,dMlength,tol,3);
320 double tol=Geom::EPSILON)
333 build_from_sbasis(pb, B[0], tol, false);
341 if (!are_near(B[prev_i].at1(), B[i].at0(), tol) )
446 build_from_sbasis(pb,arc0->toSBasis(), tol, false);
451 build_from_sbasis(pb,arc1->toSBasis(), tol, false);
527 build_from_sbasis(pb, B[i], tol, fals
316 path_from_piecewise_fix_cusps( Geom::Piecewise<Geom::D2<Geom::SBasis> > const & B, Geom::Piecewise<Geom::SBasis> const & y, LineJoinType jointype, double miter_limit, double tol=Geom::EPSILON) argument
[all...]
/inkscape/src/widgets/
H A Dpencil-toolbar.cpp296 double tol = prefs->getDoubleLimited("/tools/freehand/pencil/tolerance", 10.0, 1.0, 100.0); local
297 tol = tol/(100.0*(102.0-tol));
299 ss << tol; local
/inkscape/src/ui/tools/
H A Dpencil-tool.cpp637 double tol = prefs->getDoubleLimited("/tools/freehand/pencil/tolerance", 10.0, 1.0, 100.0) * 0.4; local
641 tol = std::min(tol,tol2);
643 double tolerance_sq = 0.02 * square(this->desktop->w2d().descrim() * tol) * exp(0.2 * tol - 2);
710 double tol = prefs->getDoubleLimited("/tools/freehand/pencil/tolerance", 10.0, 1.0, 100.0) * 0.4; local
714 tol = std::min(tol,tol2);
716 double tolerance_sq = 0.02 * square(this->desktop->w2d().descrim() * tol) * exp(0.2 * tol
[all...]
/inkscape/src/livarot/
H A DPath.h311 typedef void (outlineCallback) (outline_callback_data * data, double tol, double width);
342 static void RecStdCubicTo (outline_callback_data * data, double tol,
344 static void StdCubicTo (outline_callback_data * data, double tol,
346 static void StdBezierTo (outline_callback_data * data, double tol,
348 static void RecStdArcTo (outline_callback_data * data, double tol,
350 static void StdArcTo (outline_callback_data * data, double tol, double width);
H A DPathOutline.cpp1281 Path::RecStdCubicTo (outline_callback_data * data, double tol, double width, argument
1345 if (err <= tol ) { // tolerance is given as a quadratic value, no need to use tol*tol here
1346 // printf("%f <= %f %i\n",err,tol,lev);
1368 RecStdCubicTo (&desc, tol, width, lev - 1);
1380 RecStdCubicTo (&desc, tol, width, lev - 1);
1385 Path::StdCubicTo (Path::outline_callback_data * data, double tol, double width) argument
1388 RecStdCubicTo (data, tol, width, 8);
1392 Path::StdBezierTo (Path::outline_callback_data * data, double tol, doubl argument
1411 RecStdArcTo(outline_callback_data * data, double tol, double width, int lev) argument
1508 StdArcTo(Path::outline_callback_data * data, double tol, double width) argument
[all...]
/inkscape/src/display/
H A Ddrawing-context.h103 void setTolerance(double tol) { cairo_set_tolerance(_ct, tol); } argument

Completed in 171 milliseconds

12