| |
| |
|
|
| #include "tmathutil.h" |
| #include "tcurves.h" |
| #include "tbezier.h" |
| #include "tstrokedeformations.h" |
| #include "tstroke.h" |
| #include "tcurveutil.h" |
| #include "tcg_wrap.h" |
| |
| |
| #include "tcg/tcg_poly_ops.h" |
| |
| #define INCLUDE_HPP |
| #include "tcg/tcg_polylineops.h" |
| #include "tcg/tcg_cyclic.h" |
| #undef INCLUDE_HPP |
| |
| #include "tstrokeutil.h" |
| |
| |
| |
| |
| |
| namespace |
| { |
| |
| typedef std::vector<TThickCubic *> TThickCubicArray; |
| typedef std::vector<TThickQuadratic *> QuadStrokeChunkArray; |
| |
| |
| |
| int getControlPointIndex(const TStroke &stroke, |
| double w) |
| { |
| TThickPoint p = stroke.getControlPointAtParameter(w); |
| |
| int i = 0; |
| int controlPointCount = stroke.getControlPointCount(); |
| |
| for (; i < controlPointCount; ++i) |
| if (stroke.getControlPoint(i) == p) |
| return i; |
| |
| return controlPointCount - 1; |
| } |
| |
| |
| |
| double findMinimum(const TStrokeDeformation &def, |
| const TStroke &stroke, |
| double x1, |
| double x2, |
| double xacc, |
| double length = 0, |
| int max_iter = 100) |
| |
| { |
| int j; |
| double dx, f, fmid, xmid, rtb; |
| |
| f = def.getDelta(stroke, x1) - length; |
| fmid = def.getDelta(stroke, x2) - length; |
| |
| if (f == 0) |
| return x1; |
| if (fmid == 0) |
| return x2; |
| |
| if (f * fmid > 0.0) |
| return -1; |
| |
| rtb = f < 0.0 ? (dx = x2 - x1, x1) : (dx = x1 - x2, x2); |
| |
| for (j = 1; j <= max_iter; j++) { |
| fmid = def.getDelta(stroke, xmid = rtb + (dx *= 0.5)) - length; |
| if (fmid <= 0.0) |
| rtb = xmid; |
| if (fabs(dx) < xacc || fmid == 0.0) |
| return rtb; |
| } |
| return -2; |
| } |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| double |
| computeIncrement(double strokeLength, |
| double pixelSize) |
| { |
| assert(pixelSize > 0 && "Pixel size is negative!!!"); |
| assert(strokeLength > 0 && "Stroke Length size is negative!!!"); |
| |
| |
| double |
| height = 100; |
| |
| |
| assert(height >= 100.0); |
| |
| double |
| x = sqrt(height); |
| |
| |
| |
| |
| |
| |
| |
| |
| double |
| m = 2.0 * x; |
| |
| double |
| q = m * x - height; |
| |
| double |
| p1x = q / m; |
| |
| double |
| scale = strokeLength / (2.0 * x); |
| |
| TScale |
| scaleAffine(scale, scale); |
| |
| TPointD |
| p0 = scaleAffine * TPointD(-x, -height), |
| p1 = scaleAffine * TPointD(-p1x, 0.0), |
| p2 = scaleAffine * TPointD(0.0, 0.0); |
| |
| TQuadratic |
| quadratic(p0, |
| p1, |
| p2); |
| |
| double |
| step = computeStep(quadratic, |
| pixelSize); |
| |
| |
| if (step >= 1.0) |
| step = 0.1; |
| |
| return step; |
| } |
| |
| |
| |
| void detectEdges(const std::vector<TPointD> &pointArray, std::vector<UINT> &edgeIndexArray) |
| { |
| |
| |
| int size = pointArray.size(); |
| |
| if (size < 3) |
| return; |
| |
| |
| |
| |
| |
| |
| |
| |
| const double dMin = 4; |
| const double dMax = dMin + 3; |
| const double alphaMax = 2.4; |
| const double dMin2 = dMin * dMin; |
| const double dMax2 = dMax * dMax; |
| std::vector<double> sharpnessArray; |
| sharpnessArray.push_back(M_PI); |
| int nodeCount; |
| for (nodeCount = 1; nodeCount < size - 1; ++nodeCount) { |
| sharpnessArray.push_back(0); |
| TPointD point(pointArray[nodeCount]); |
| int leftCount; |
| for (leftCount = nodeCount - 1; leftCount >= 0; --leftCount) { |
| TPointD left = pointArray[leftCount]; |
| double dLeft2 = norm2(left - point); |
| if (dLeft2 < dMin2) |
| continue; |
| else if (dLeft2 > dMax2) |
| break; |
| int rightCount; |
| for (rightCount = nodeCount + 1; rightCount < size; ++rightCount) { |
| TPointD right = pointArray[rightCount]; |
| double dRight2 = norm2(right - point); |
| if (dRight2 < dMin2) |
| continue; |
| else if (dMax2 < dRight2) |
| break; |
| |
| |
| double dCenter2 = norm2(left - right); |
| assert(dLeft2 != 0.0 && dRight2 != 0.0); |
| |
| double cs = (dLeft2 + dRight2 - dCenter2) / (2 * sqrt(dLeft2 * dRight2)); |
| double alpha = acos(cs); |
| if (alpha > alphaMax) |
| continue; |
| |
| double sharpness = M_PI - alpha; |
| |
| if (sharpnessArray[nodeCount] < sharpness) |
| sharpnessArray[nodeCount] = sharpness; |
| } |
| } |
| } |
| |
| edgeIndexArray.push_back(0); |
| |
| |
| for (nodeCount = 1; nodeCount < size - 1; ++nodeCount) { |
| bool isCorner = true; |
| TPointD point(pointArray[nodeCount]); |
| int leftCount; |
| for (leftCount = nodeCount - 1; leftCount >= 0; --leftCount) { |
| TPointD left = pointArray[leftCount]; |
| double dLeft2 = norm2(left - point); |
| if (dLeft2 > dMax2) |
| break; |
| if (sharpnessArray[leftCount] > sharpnessArray[nodeCount]) { |
| isCorner = false; |
| break; |
| } |
| } |
| if (isCorner) |
| continue; |
| int rightCount; |
| for (rightCount = nodeCount + 1; rightCount < size; ++rightCount) { |
| TPointD right = pointArray[rightCount]; |
| double dRight2 = norm2(right - point); |
| if (dRight2 > dMax2) |
| break; |
| if (sharpnessArray[rightCount] > sharpnessArray[nodeCount]) { |
| isCorner = false; |
| break; |
| } |
| } |
| if (isCorner) |
| edgeIndexArray.push_back(nodeCount); |
| } |
| edgeIndexArray.push_back(size - 1); |
| } |
| |
| } |
| |
| |
| |
| |
| |
| bool increaseControlPoints(TStroke &stroke, |
| const TStrokeDeformation &deformer, |
| double pixelSize) |
| { |
| |
| if (isAlmostZero(stroke.getLength())) { |
| return norm2(deformer.getDisplacement(stroke, 0.0)) > 0; |
| } |
| |
| |
| |
| |
| bool notVoidPotential = false; |
| |
| for (int i = 0; i < stroke.getControlPointCount(); ++i) { |
| double par = stroke.getParameterAtControlPoint(i); |
| if (deformer.getDisplacement(stroke, par) != TThickPoint()) { |
| notVoidPotential = true; |
| break; |
| } |
| } |
| |
| |
| |
| double maxDifference = deformer.getMaxDiff(); |
| |
| int strokeControlPoint = stroke.getControlPointCount(); |
| |
| |
| |
| if (pixelSize < TConsts::epsilon) |
| pixelSize = TConsts::epsilon; |
| |
| double |
| length = stroke.getLength(), |
| |
| |
| |
| w = 0.0; |
| |
| double |
| step = computeIncrement(length, |
| pixelSize); |
| |
| double x1, x2, d1, d2, diff, offset, minimum, incr; |
| |
| incr = step; |
| |
| while (w + incr < 1.0) { |
| d1 = deformer.getDelta(stroke, w); |
| d2 = deformer.getDelta(stroke, w + incr); |
| |
| diff = d2 - d1; |
| |
| if (fabs(diff) >= maxDifference) |
| { |
| if (tsign(diff) > 0) { |
| x1 = w; |
| x2 = w + incr; |
| } else { |
| x1 = w + incr; |
| x2 = w; |
| } |
| |
| offset = (d1 + d2) * 0.5; |
| |
| |
| minimum = findMinimum(deformer, stroke, x1, x2, TConsts::epsilon, offset, 20); |
| |
| |
| |
| |
| if (minimum < 0 || w == minimum) { |
| minimum = w + incr * 0.5; |
| w += step; |
| } |
| |
| |
| w = minimum; |
| stroke.insertControlPoints(minimum); |
| |
| |
| incr = step; |
| } else |
| incr += step; |
| } |
| |
| |
| return (stroke.getControlPointCount() > strokeControlPoint) || notVoidPotential; |
| } |
| |
| |
| |
| void modifyControlPoints(TStroke &stroke, |
| const TStrokeDeformation &deformer) |
| { |
| int cpCount = stroke.getControlPointCount(); |
| |
| TThickPoint newP; |
| |
| for (int i = 0; i < cpCount; ++i) { |
| newP = stroke.getControlPoint(i) + deformer.getDisplacementForControlPoint(stroke, i); |
| if (isAlmostZero(newP.thick, 0.005)) |
| newP.thick = 0; |
| stroke.setControlPoint(i, newP); |
| } |
| } |
| |
| |
| |
| void modifyControlPoints(TStroke &stroke, |
| const TStrokeDeformation &deformer, std::vector<double> &controlPointLen) |
| { |
| UINT cpCount = stroke.getControlPointCount(); |
| |
| TThickPoint newP; |
| |
| #ifdef _DEBUG |
| UINT debugVariable = controlPointLen.size(); |
| #endif |
| assert(controlPointLen.size() == cpCount); |
| |
| for (UINT i = 0; i < cpCount; ++i) { |
| newP = stroke.getControlPoint(i) + deformer.getDisplacementForControlPointLen(stroke, controlPointLen[i]); |
| if (isAlmostZero(newP.thick, 0.005)) |
| newP.thick = 0; |
| stroke.setControlPoint(i, newP); |
| } |
| } |
| |
| |
| |
| void modifyThickness(TStroke &stroke, const TStrokeDeformation &deformer, |
| std::vector<double> &controlPointLen, bool exponentially) |
| { |
| UINT cpCount = stroke.getControlPointCount(); |
| assert(controlPointLen.size() == cpCount); |
| |
| double disp; |
| double thick; |
| |
| for (UINT i = 0; i < cpCount; ++i) { |
| disp = (deformer.getDisplacementForControlPointLen(stroke, controlPointLen[i])).thick; |
| |
| thick = stroke.getControlPoint(i).thick; |
| |
| |
| |
| |
| |
| thick = (exponentially && thick >= 0.005) ? thick * exp(disp / thick) : thick + disp; |
| |
| if (thick < 0.005) |
| thick = 0.0; |
| |
| stroke.setControlPoint(i, TThickPoint(stroke.getControlPoint(i), thick)); |
| } |
| } |
| |
| |
| |
| void transform_thickness(TStroke &stroke, const double poly[], int deg) |
| { |
| int cp, cpCount = stroke.getControlPointCount(); |
| for (cp = 0; cp != cpCount; ++cp) { |
| TThickPoint cpPoint = stroke.getControlPoint(cp); |
| cpPoint.thick = std::max( |
| tcg::poly_ops::evaluate(poly, deg, cpPoint.thick), |
| 0.0); |
| |
| stroke.setControlPoint(cp, cpPoint); |
| } |
| } |
| |
| |
| |
| TStroke *Toonz::merge(const std::vector<TStroke *> &strokes) |
| { |
| if (strokes.empty()) |
| return 0; |
| |
| std::vector<TThickPoint> |
| new_stroke_cp; |
| |
| int |
| size_stroke_array = strokes.size(); |
| |
| int |
| size_cp; |
| |
| const TStroke * |
| ref; |
| |
| TThickPoint |
| last = TConsts::natp; |
| |
| if (!strokes[0]) |
| return 0; |
| |
| new_stroke_cp.push_back(strokes[0]->getControlPoint(0)); |
| int i, j; |
| for (i = 0; |
| i < size_stroke_array; |
| i++) { |
| ref = strokes[i]; |
| if (!ref) |
| return 0; |
| |
| size_cp = ref->getControlPointCount(); |
| for (j = 0; |
| j < size_cp - 1; |
| j++) { |
| const TThickPoint & |
| pnt = ref->getControlPoint(j); |
| |
| if (last != TConsts::natp && |
| j == 0) { |
| |
| new_stroke_cp.push_back(last); |
| } |
| |
| if (j > 0) |
| new_stroke_cp.push_back(pnt); |
| } |
| |
| last = ref->getControlPoint(size_cp - 1); |
| } |
| |
| new_stroke_cp.push_back(ref->getControlPoint(size_cp - 1)); |
| |
| TStroke *out = new TStroke(new_stroke_cp); |
| return out; |
| } |
| |
| |
| |
| namespace |
| { |
| |
| class CpsReader |
| { |
| std::vector<TThickPoint> &m_cps; |
| |
| public: |
| typedef TPointD value_type; |
| |
| public: |
| CpsReader(std::vector<TThickPoint> &cps) : m_cps(cps) {} |
| |
| void openContainer(const TPointD &point) { addElement(point); } |
| void addElement(const TPointD &point) { m_cps.push_back(TThickPoint(point, 0.0)); } |
| void closeContainer() {} |
| }; |
| |
| |
| |
| |
| |
| template <typename iter_type> |
| double buildLength(const iter_type &begin, const iter_type &end, double tol) |
| { |
| |
| iter_type it = begin, jt; |
| ++it; |
| |
| const TPointD &a = *begin, &b = *it; |
| |
| TPointD dir(normalize(b - a)), segDir; |
| double dist; |
| |
| for (jt = it, ++it; it != end; jt = it, ++it) { |
| segDir = *it - *jt; |
| if (dir * segDir < 0) |
| break; |
| |
| dist = tcg::point_ops::lineSignedDist(*it, a, dir); |
| if (fabs(dist) > tol) { |
| double s, t; |
| if (dist > 0) { |
| tcg::point_ops::intersectionCoords(*jt, segDir, |
| a + tol * tcg::point_ops::ortLeft(dir), dir, s, t); |
| } else { |
| tcg::point_ops::intersectionCoords(*jt, segDir, |
| a + tol * tcg::point_ops::ortRight(dir), dir, s, t); |
| } |
| |
| s = tcrop(s, 0.0, 1.0); |
| return (*jt + s * segDir - a) * dir; |
| } |
| } |
| |
| return (*jt - a) * dir; |
| } |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| |
| class TripletsConverter |
| { |
| typedef std::vector<TPointD>::const_iterator iter_type; |
| typedef std::reverse_iterator<iter_type> riter_type; |
| typedef tcg::cyclic_iterator<iter_type> cyclic_iter_type; |
| typedef std::reverse_iterator<cyclic_iter_type> rcyclic_iter_type; |
| |
| bool m_circular; |
| iter_type m_first, m_end, m_last; |
| double m_adherenceTol, m_angleTol, m_relativeTol, m_relativeDistTol; |
| |
| public: |
| TripletsConverter(const iter_type &begin, const iter_type &end, |
| double adherenceTol, double angleTol, |
| double relativeTol, double relativeDistTol) |
| : m_circular(*begin == *(end - 1)), m_first(m_circular ? begin + 1 : begin), m_end(end), m_adherenceTol(adherenceTol), m_angleTol(angleTol), m_relativeTol(relativeTol), m_relativeDistTol(relativeDistTol) {} |
| |
| |
| void operator()(const TPointD &a, const iter_type &bt, const TPointD &c, |
| tcg::sequential_reader<std::vector<TPointD>> &output) |
| { |
| const TPointD &b = *bt; |
| |
| double prod = tcg::point_ops::direction(b, a) * tcg::point_ops::direction(b, c); |
| |
| if (prod > m_angleTol) { |
| |
| output.addElement(0.5 * (a + b)); |
| output.addElement(b); |
| output.addElement(0.5 * (b + c)); |
| } else { |
| |
| TPointD a_b(a - b); |
| TPointD c_b(c - b); |
| |
| double norm_a_b = norm(a_b); |
| double norm_c_b = norm(c_b); |
| |
| a_b = a_b * (1.0 / norm_a_b); |
| c_b = c_b * (1.0 / norm_c_b); |
| |
| TPointD v(tcg::point_ops::normalized(a_b + c_b)); |
| double cos_v_dir = fabs(a_b * v); |
| |
| double t1 = tcrop(m_adherenceTol / (cos_v_dir * norm_a_b), 0.0, 0.5); |
| double t2 = tcrop(m_adherenceTol / (cos_v_dir * norm_c_b), 0.0, 0.5); |
| |
| if (t1 == 0.5 && t2 == 0.5) { |
| |
| output.addElement(b); |
| } else { |
| |
| TPointD d(b + t1 * (a - b)), f(b + t2 * (c - b)), e(0.5 * (d + f)); |
| |
| |
| |
| |
| |
| |
| TPointD speed(f - d); |
| |
| double num = norm(speed); |
| if (num <= TConsts::epsilon) { |
| |
| output.addElement(0.5 * (a + b)); |
| output.addElement(b); |
| output.addElement(0.5 * (b + c)); |
| } else { |
| num = 2.0 * num * num * num; |
| |
| double den1 = fabs(cross(speed, a - d)); |
| double den2 = fabs(cross(speed, c - f)); |
| |
| double radius1 = (den1 == 0.0) ? 0.0 : num / den1; |
| double radius2 = (den1 == 0.0) ? 0.0 : num / den2; |
| |
| |
| double length1, length2; |
| if (m_circular) { |
| cyclic_iter_type it(bt, m_first, m_end, 0); |
| cyclic_iter_type it1(bt, m_first, m_end, 1); |
| cyclic_iter_type it_1(bt, m_first, m_end, -1); |
| rcyclic_iter_type rit(it + 1), rit1(it_1 + 1); |
| |
| length1 = buildLength(rit, rit1, 0.25); |
| length2 = buildLength(it, it1, 0.25); |
| } else { |
| riter_type rit(bt + 1), rend(m_first); |
| |
| length1 = buildLength(rit, rend, m_relativeDistTol); |
| length2 = buildLength(bt, m_end, m_relativeDistTol); |
| } |
| |
| |
| if (radius1 / length1 < m_relativeTol && |
| radius2 / length2 < m_relativeTol) { |
| |
| output.addElement(0.5 * (a + b)); |
| output.addElement(b); |
| output.addElement(0.5 * (b + c)); |
| } else { |
| |
| output.addElement(d); |
| output.addElement(e); |
| output.addElement(f); |
| } |
| } |
| } |
| } |
| |
| output.addElement(c); |
| } |
| }; |
| |
| } |
| |
| |
| |
| void polylineToQuadratics(const std::vector<TPointD> &polyline, |
| std::vector<TThickPoint> &cps, |
| double adherenceTol, double angleTol, |
| double relativeTol, double relativeDistTol, |
| double mergeTol) |
| { |
| CpsReader cpsReader(cps); |
| TripletsConverter op(polyline.begin(), polyline.end(), |
| adherenceTol, angleTol, relativeTol, relativeDistTol); |
| tcg::polyline_ops::toQuadratics(polyline.begin(), polyline.end(), cpsReader, op, mergeTol); |
| } |
| |