X-Git-Url: https://git.tokkee.org/?a=blobdiff_plain;f=src%2Fextension%2Finternal%2Fodf.cpp;h=fcb9c23d2389dd7fea5b9643d4ee32b013ab291b;hb=e7a6cdbae48a22005ba8e198c89f2cf0796e47c9;hp=37f26966c774e307b9382dfe6c079723275237df;hpb=82e21ba48b3bef514f856748d1ca20178b146be8;p=inkscape.git diff --git a/src/extension/internal/odf.cpp b/src/extension/internal/odf.cpp index 37f26966c..fcb9c23d2 100644 --- a/src/extension/internal/odf.cpp +++ b/src/extension/internal/odf.cpp @@ -5,7 +5,10 @@ * the inputting and outputting of OpenDocument Format (ODF) files from * within Inkscape. Although the initial implementations will be very lossy * do to the differences in the models of SVG and ODF, they will hopefully - * improve greatly with time. + * improve greatly with time. People should consider this to be a framework + * that can be continously upgraded for ever improving fidelity. Potential + * developers should especially look in preprocess() and writeTree() to see how + * the SVG tree is scanned, read, translated, and then written to ODF. * * http://www.w3.org/TR/2004/REC-DOM-Level-3-Core-20040407/idl-definitions.html * @@ -34,10 +37,18 @@ #ifdef HAVE_CONFIG_H # include #endif + #include "odf.h" + +//# System includes +#include +#include +#include + + +//# Inkscape includes #include "clear-n_.h" #include "inkscape.h" -#include "sp-path.h" #include #include "display/curve.h" #include "libnr/n-art-bpath.h" @@ -45,15 +56,27 @@ #include "xml/repr.h" #include "xml/attribute-record.h" +#include "sp-image.h" +#include "sp-gradient.h" +#include "sp-linear-gradient.h" +#include "sp-radial-gradient.h" +#include "sp-path.h" +#include "sp-text.h" +#include "sp-flowtext.h" +#include "svg/svg.h" +#include "text-editing.h" -#include +//# DOM-specific includes #include "dom/dom.h" #include "dom/util/ziptool.h" +#include "dom/io/domstream.h" +#include "dom/io/bufferstream.h" +#include "dom/io/stringstream.h" + + -//# Shorthand notation -typedef org::w3c::dom::DOMString DOMString; namespace Inkscape @@ -65,267 +88,1552 @@ namespace Internal +//# Shorthand notation +typedef org::w3c::dom::DOMString DOMString; +typedef org::w3c::dom::XMLCh XMLCh; +typedef org::w3c::dom::io::OutputStreamWriter OutputStreamWriter; +typedef org::w3c::dom::io::BufferOutputStream BufferOutputStream; +typedef org::w3c::dom::io::StringOutputStream StringOutputStream; + +//######################################################################## +//# C L A S S SingularValueDecomposition +//######################################################################## +#include -class ImageInfo +class SVDMatrix { public: - ImageInfo(const DOMString &nameArg, - const DOMString &newNameArg, - const std::vector &bufArg) + SVDMatrix() { - name = nameArg; - newName = newNameArg; - buf = bufArg; + init(); } - virtual ~ImageInfo() - {} + SVDMatrix(unsigned int rowSize, unsigned int colSize) + { + init(); + rows = rowSize; + cols = colSize; + size = rows * cols; + d = new double[size]; + for (unsigned int i=0 ; i getBuf() + virtual ~SVDMatrix() { - return buf; + delete[] d; } - DOMString name; - DOMString newName; - std::vectorbuf; + double& operator() (unsigned int row, unsigned int col) + { + if (row >= rows || col >= cols) + return badval; + return d[cols*row + col]; + } + + double operator() (unsigned int row, unsigned int col) const + { + if (row >= rows || col >= cols) + return badval; + return d[cols*row + col]; + } + + unsigned int getRows() + { + return rows; + } + + unsigned int getCols() + { + return cols; + } + + SVDMatrix multiply(const SVDMatrix &other) + { + if (cols != other.rows) + { + SVDMatrix dummy; + return dummy; + } + SVDMatrix result(rows, other.cols); + for (unsigned int i=0 ; i + * For an m-by-n matrix A with m >= n, the singular value decomposition is + * an m-by-n orthogonal matrix U, an n-by-n diagonal matrix S, and + * an n-by-n orthogonal matrix V so that A = U*S*V'. + *

+ * The singular values, sigma[k] = S[k][k], are ordered so that + * sigma[0] >= sigma[1] >= ... >= sigma[n-1]. + *

+ * The singular value decompostion always exists, so the constructor will + * never fail. The matrix condition number and the effective numerical + * rank can be computed from this decomposition. + */ +class SingularValueDecomposition { public: - StyleInfo(const DOMString &nameArg, const DOMString &styleArg) + /** Construct the singular value decomposition + @param A Rectangular matrix + @return Structure to access U, S and V. + */ + + SingularValueDecomposition (const SVDMatrix &mat) { - name = nameArg; - style = styleArg; - fill = "none"; - stroke = "none"; + A = mat; + s = NULL; + s_size = 0; + calculate(); } - virtual ~StyleInfo() - {} - - DOMString getName() + virtual ~SingularValueDecomposition() { - return name; + delete[] s; } - DOMString getCssStyle() + /** + * Return the left singular vectors + * @return U + */ + SVDMatrix &getU(); + + /** + * Return the right singular vectors + * @return V + */ + SVDMatrix &getV(); + + /** + * Return the s[index] value + */ double getS(unsigned int index); + + /** + * Two norm + * @return max(S) + */ + double norm2(); + + /** + * Two norm condition number + * @return max(S)/min(S) + */ + double cond(); + + /** + * Effective numerical matrix rank + * @return Number of nonnegligible singular values. + */ + int rank(); + +private: + + void calculate(); + + SVDMatrix A; + SVDMatrix U; + double *s; + unsigned int s_size; + SVDMatrix V; + +}; + + +static double svd_hypot(double a, double b) +{ + double r; + + if (fabs(a) > fabs(b)) { - return cssStyle; + r = b/a; + r = fabs(a) * sqrt(1+r*r); } - - DOMString getStroke() + else if (b != 0) { - return stroke; + r = a/b; + r = fabs(b) * sqrt(1+r*r); } + else + { + r = 0.0; + } + return r; +} - DOMString getStrokeColor() + + +void SingularValueDecomposition::calculate() +{ + // Initialize. + int m = A.getRows(); + int n = A.getCols(); + + int nu = (m > n) ? m : n; + s_size = (m+1 < n) ? m+1 : n; + s = new double[s_size]; + U = SVDMatrix(m, nu); + V = SVDMatrix(n, n); + double *e = new double[n]; + double *work = new double[m]; + bool wantu = true; + bool wantv = true; + + // Reduce A to bidiagonal form, storing the diagonal elements + // in s and the super-diagonal elements in e. + + int nct = (m-10) ? nrtx : 0; + for (int k = 0; k < 2; k++) { + if (k < nct) { + + // Compute the transformation for the k-th column and + // place the k-th diagonal in s[k]. + // Compute 2-norm of k-th column without under/overflow. + s[k] = 0; + for (int i = k; i < m; i++) { + s[k] = svd_hypot(s[k],A(i, k)); + } + if (s[k] != 0.0) { + if (A(k, k) < 0.0) { + s[k] = -s[k]; + } + for (int i = k; i < m; i++) { + A(i, k) /= s[k]; + } + A(k, k) += 1.0; + } + s[k] = -s[k]; + } + for (int j = k+1; j < n; j++) { + if ((k < nct) & (s[k] != 0.0)) { + + // Apply the transformation. + + double t = 0; + for (int i = k; i < m; i++) { + t += A(i, k) * A(i, j); + } + t = -t/A(k, k); + for (int i = k; i < m; i++) { + A(i, j) += t*A(i, k); + } + } + + // Place the k-th row of A into e for the + // subsequent calculation of the row transformation. + + e[j] = A(k, j); + } + if (wantu & (k < nct)) { + + // Place the transformation in U for subsequent back + // multiplication. + + for (int i = k; i < m; i++) { + U(i, k) = A(i, k); + } + } + if (k < nrt) { + + // Compute the k-th row transformation and place the + // k-th super-diagonal in e[k]. + // Compute 2-norm without under/overflow. + e[k] = 0; + for (int i = k+1; i < n; i++) { + e[k] = svd_hypot(e[k],e[i]); + } + if (e[k] != 0.0) { + if (e[k+1] < 0.0) { + e[k] = -e[k]; + } + for (int i = k+1; i < n; i++) { + e[i] /= e[k]; + } + e[k+1] += 1.0; + } + e[k] = -e[k]; + if ((k+1 < m) & (e[k] != 0.0)) { + + // Apply the transformation. + + for (int i = k+1; i < m; i++) { + work[i] = 0.0; + } + for (int j = k+1; j < n; j++) { + for (int i = k+1; i < m; i++) { + work[i] += e[j]*A(i, j); + } + } + for (int j = k+1; j < n; j++) { + double t = -e[j]/e[k+1]; + for (int i = k+1; i < m; i++) { + A(i, j) += t*work[i]; + } + } + } + if (wantv) { + + // Place the transformation in V for subsequent + // back multiplication. + + for (int i = k+1; i < n; i++) { + V(i, k) = e[i]; + } + } + } + } + + // Set up the final bidiagonal matrix or order p. + + int p = (n < m+1) ? n : m+1; + if (nct < n) { + s[nct] = A(nct, nct); + } + if (m < p) { + s[p-1] = 0.0; + } + if (nrt+1 < p) { + e[nrt] = A(nrt, p-1); + } + e[p-1] = 0.0; + + // If required, generate U. + + if (wantu) { + for (int j = nct; j < nu; j++) { + for (int i = 0; i < m; i++) { + U(i, j) = 0.0; + } + U(j, j) = 1.0; + } + for (int k = nct-1; k >= 0; k--) { + if (s[k] != 0.0) { + for (int j = k+1; j < nu; j++) { + double t = 0; + for (int i = k; i < m; i++) { + t += U(i, k)*U(i, j); + } + t = -t/U(k, k); + for (int i = k; i < m; i++) { + U(i, j) += t*U(i, k); + } + } + for (int i = k; i < m; i++ ) { + U(i, k) = -U(i, k); + } + U(k, k) = 1.0 + U(k, k); + for (int i = 0; i < k-1; i++) { + U(i, k) = 0.0; + } + } else { + for (int i = 0; i < m; i++) { + U(i, k) = 0.0; + } + U(k, k) = 1.0; + } + } + } + + // If required, generate V. + + if (wantv) { + for (int k = n-1; k >= 0; k--) { + if ((k < nrt) & (e[k] != 0.0)) { + for (int j = k+1; j < nu; j++) { + double t = 0; + for (int i = k+1; i < n; i++) { + t += V(i, k)*V(i, j); + } + t = -t/V(k+1, k); + for (int i = k+1; i < n; i++) { + V(i, j) += t*V(i, k); + } + } + } + for (int i = 0; i < n; i++) { + V(i, k) = 0.0; + } + V(k, k) = 1.0; + } + } + + // Main iteration loop for the singular values. + + int pp = p-1; + int iter = 0; + //double eps = pow(2.0,-52.0); + //double tiny = pow(2.0,-966.0); + //let's just calculate these now + //a double can be e ± 308.25, so this is safe + double eps = 2.22e-16; + double tiny = 1.6e-291; + while (p > 0) { + int k,kase; + + // Here is where a test for too many iterations would go. + + // This section of the program inspects for + // negligible elements in the s and e arrays. On + // completion the variables kase and k are set as follows. + + // kase = 1 if s(p) and e[k-1] are negligible and k

= -1; k--) { + if (k == -1) { + break; + } + if (fabs(e[k]) <= + tiny + eps*(fabs(s[k]) + fabs(s[k+1]))) { + e[k] = 0.0; + break; + } + } + if (k == p-2) { + kase = 4; + } else { + int ks; + for (ks = p-1; ks >= k; ks--) { + if (ks == k) { + break; + } + double t = (ks != p ? fabs(e[ks]) : 0.) + + (ks != k+1 ? fabs(e[ks-1]) : 0.); + if (fabs(s[ks]) <= tiny + eps*t) { + s[ks] = 0.0; + break; + } + } + if (ks == k) { + kase = 3; + } else if (ks == p-1) { + kase = 1; + } else { + kase = 2; + k = ks; + } + } + k++; + + // Perform the task indicated by kase. + + switch (kase) { + + // Deflate negligible s(p). + + case 1: { + double f = e[p-2]; + e[p-2] = 0.0; + for (int j = p-2; j >= k; j--) { + double t = svd_hypot(s[j],f); + double cs = s[j]/t; + double sn = f/t; + s[j] = t; + if (j != k) { + f = -sn*e[j-1]; + e[j-1] = cs*e[j-1]; + } + if (wantv) { + for (int i = 0; i < n; i++) { + t = cs*V(i, j) + sn*V(i, p-1); + V(i, p-1) = -sn*V(i, j) + cs*V(i, p-1); + V(i, j) = t; + } + } + } + } + break; + + // Split at negligible s(k). + + case 2: { + double f = e[k-1]; + e[k-1] = 0.0; + for (int j = k; j < p; j++) { + double t = svd_hypot(s[j],f); + double cs = s[j]/t; + double sn = f/t; + s[j] = t; + f = -sn*e[j]; + e[j] = cs*e[j]; + if (wantu) { + for (int i = 0; i < m; i++) { + t = cs*U(i, j) + sn*U(i, k-1); + U(i, k-1) = -sn*U(i, j) + cs*U(i, k-1); + U(i, j) = t; + } + } + } + } + break; + + // Perform one qr step. + + case 3: { + + // Calculate the shift. + + double scale = fabs(s[p-1]); + double d = fabs(s[p-2]); + if (d>scale) scale=d; + d = fabs(e[p-2]); + if (d>scale) scale=d; + d = fabs(s[k]); + if (d>scale) scale=d; + d = fabs(e[k]); + if (d>scale) scale=d; + double sp = s[p-1]/scale; + double spm1 = s[p-2]/scale; + double epm1 = e[p-2]/scale; + double sk = s[k]/scale; + double ek = e[k]/scale; + double b = ((spm1 + sp)*(spm1 - sp) + epm1*epm1)/2.0; + double c = (sp*epm1)*(sp*epm1); + double shift = 0.0; + if ((b != 0.0) | (c != 0.0)) { + shift = sqrt(b*b + c); + if (b < 0.0) { + shift = -shift; + } + shift = c/(b + shift); + } + double f = (sk + sp)*(sk - sp) + shift; + double g = sk*ek; + + // Chase zeros. + + for (int j = k; j < p-1; j++) { + double t = svd_hypot(f,g); + double cs = f/t; + double sn = g/t; + if (j != k) { + e[j-1] = t; + } + f = cs*s[j] + sn*e[j]; + e[j] = cs*e[j] - sn*s[j]; + g = sn*s[j+1]; + s[j+1] = cs*s[j+1]; + if (wantv) { + for (int i = 0; i < n; i++) { + t = cs*V(i, j) + sn*V(i, j+1); + V(i, j+1) = -sn*V(i, j) + cs*V(i, j+1); + V(i, j) = t; + } + } + t = svd_hypot(f,g); + cs = f/t; + sn = g/t; + s[j] = t; + f = cs*e[j] + sn*s[j+1]; + s[j+1] = -sn*e[j] + cs*s[j+1]; + g = sn*e[j+1]; + e[j+1] = cs*e[j+1]; + if (wantu && (j < m-1)) { + for (int i = 0; i < m; i++) { + t = cs*U(i, j) + sn*U(i, j+1); + U(i, j+1) = -sn*U(i, j) + cs*U(i, j+1); + U(i, j) = t; + } + } + } + e[p-2] = f; + iter = iter + 1; + } + break; + + // Convergence. + + case 4: { + + // Make the singular values positive. + + if (s[k] <= 0.0) { + s[k] = (s[k] < 0.0 ? -s[k] : 0.0); + if (wantv) { + for (int i = 0; i <= pp; i++) { + V(i, k) = -V(i, k); + } + } + } + + // Order the singular values. + + while (k < pp) { + if (s[k] >= s[k+1]) { + break; + } + double t = s[k]; + s[k] = s[k+1]; + s[k+1] = t; + if (wantv && (k < n-1)) { + for (int i = 0; i < n; i++) { + t = V(i, k+1); V(i, k+1) = V(i, k); V(i, k) = t; + } + } + if (wantu && (k < m-1)) { + for (int i = 0; i < m; i++) { + t = U(i, k+1); U(i, k+1) = U(i, k); U(i, k) = t; + } + } + k++; + } + iter = 0; + p--; + } + break; + } + } + + delete e; + delete work; + +} + + + +/** + * Return the left singular vectors + * @return U + */ +SVDMatrix &SingularValueDecomposition::getU() +{ + return U; +} + +/** + * Return the right singular vectors + * @return V + */ + +SVDMatrix &SingularValueDecomposition::getV() +{ + return V; +} + +/** + * Return the s[0] value + */ +double SingularValueDecomposition::getS(unsigned int index) +{ + if (index >= s_size) + return 0.0; + return s[index]; +} + +/** + * Two norm + * @return max(S) + */ +double SingularValueDecomposition::norm2() +{ + return s[0]; +} + +/** + * Two norm condition number + * @return max(S)/min(S) + */ + +double SingularValueDecomposition::cond() +{ + return s[0]/s[2]; +} + +/** + * Effective numerical matrix rank + * @return Number of nonnegligible singular values. + */ +int SingularValueDecomposition::rank() +{ + double eps = pow(2.0,-52.0); + double tol = 3.0*s[0]*eps; + int r = 0; + for (int i = 0; i < 3; i++) { - return strokeColor; + if (s[i] > tol) + r++; } + return r; +} + +//######################################################################## +//# E N D C L A S S SingularValueDecomposition +//######################################################################## + + + + + +#define pi 3.14159 +//#define pxToCm 0.0275 +#define pxToCm 0.03 +#define piToRad 0.0174532925 +#define docHeightCm 22.86 - DOMString getStrokeWidth() + +//######################################################################## +//# O U T P U T +//######################################################################## + +/** + * Get the value of a node/attribute pair + */ +static Glib::ustring getAttribute( Inkscape::XML::Node *node, char *attrName) +{ + Glib::ustring val; + char *valstr = (char *)node->attribute(attrName); + if (valstr) + val = (const char *)valstr; + return val; +} + + + +/** + * Get the extension suffix from the end of a file name + */ +static Glib::ustring getExtension(const Glib::ustring &fname) +{ + Glib::ustring ext; + + unsigned int pos = fname.rfind('.'); + if (pos == fname.npos) + { + ext = ""; + } + else { - return strokeWidth; + ext = fname.substr(pos); } + return ext; +} - DOMString getFill() +static Glib::ustring formatTransform(NR::Matrix &tf) +{ + Glib::ustring str; + if (!tf.test_identity()) { - return fill; + StringOutputStream outs; + OutputStreamWriter out(outs); + out.printf("matrix(%.3f %.3f %.3f %.3f %.3f %.3f)", + tf[0], tf[1], tf[2], tf[3], tf[4], tf[5]); + str = outs.getString(); } + return str; +} - DOMString getFillColor() + +/** + * Encode a string, checking for XML entities, to + * make an XML string safe for output + */ +static Glib::ustring toXml(const Glib::ustring &str) +{ + Glib::ustring outbuf; + for (unsigned int i=0 ; i') + outbuf.append(">"); + else if (ch == '"') + outbuf.append("""); + else if (ch == '\'') + outbuf.append("'"); + else + outbuf.push_back(ch); } + return outbuf; +} - DOMString name; - DOMString style; - DOMString cssStyle; - DOMString stroke; - DOMString strokeColor; - DOMString strokeWidth; - DOMString fill; - DOMString fillColor; -}; -//######################################################################## -//# O U T P U T -//######################################################################## -void OdfOutput::po(char *str) +/** + * Get the general transform from SVG pixels to + * ODF cm + */ +static NR::Matrix getODFTransform(const SPItem *item) +{ + //### Get SVG-to-ODF transform + NR::Matrix tf; + tf = sp_item_i2d_affine(item); + //Flip Y into document coordinates + double doc_height = sp_document_height(SP_ACTIVE_DOCUMENT); + NR::Matrix doc2dt_tf = NR::Matrix(NR::scale(1.0, -1.0)); + doc2dt_tf = doc2dt_tf * NR::Matrix(NR::translate(0, doc_height)); + tf = tf * doc2dt_tf; + tf = tf * NR::Matrix(NR::scale(pxToCm)); + return tf; +} + + + + +/** + * Get the bounding box of an item, as mapped onto + * an ODF document, in cm. + */ +static NR::Rect getODFBoundingBox(const SPItem *item) { - if (str) - while (*str) - outs.put(*str++); + NR::Rect bbox = sp_item_bbox_desktop((SPItem *)item); + double doc_height = sp_document_height(SP_ACTIVE_DOCUMENT); + NR::Matrix doc2dt_tf = NR::Matrix(NR::scale(1.0, -1.0)); + doc2dt_tf = doc2dt_tf * NR::Matrix(NR::translate(0, doc_height)); + bbox = bbox * doc2dt_tf; + bbox = bbox * NR::Matrix(NR::scale(pxToCm)); + return bbox; } +/** + * Get the transform for an item, correcting for + * handedness reversal + */ +static NR::Matrix getODFItemTransform(const SPItem *item) +{ + NR::Matrix itemTransform = NR::Matrix(NR::scale(1, -1)); + itemTransform = itemTransform * item->transform; + itemTransform = itemTransform * NR::Matrix(NR::scale(1, -1)); + return itemTransform; +} /** - * This function searches the Repr tree recursively from the given node, - * and adds refs to all nodes with the given name, to the result vector + * Get some fun facts from the transform */ -static void -findElementsByTagName(std::vector &results, - Inkscape::XML::Node *node, - char const *name) +static void analyzeTransform(NR::Matrix &tf, + double &rotate, double &xskew, double &yskew, + double &xscale, double &yscale) +{ + SVDMatrix mat(2, 2); + mat(0, 0) = tf[0]; + mat(0, 1) = tf[1]; + mat(1, 0) = tf[2]; + mat(1, 1) = tf[3]; + + SingularValueDecomposition svd(mat); + + SVDMatrix U = svd.getU(); + SVDMatrix V = svd.getV(); + SVDMatrix Vt = V.transpose(); + SVDMatrix UVt = U.multiply(Vt); + double s0 = svd.getS(0); + double s1 = svd.getS(1); + xscale = s0; + yscale = s1; + //g_message("## s0:%.3f s1:%.3f", s0, s1); + //g_message("## u:%.3f %.3f %.3f %.3f", U(0,0), U(0,1), U(1,0), U(1,1)); + //g_message("## v:%.3f %.3f %.3f %.3f", V(0,0), V(0,1), V(1,0), V(1,1)); + //g_message("## vt:%.3f %.3f %.3f %.3f", Vt(0,0), Vt(0,1), Vt(1,0), Vt(1,1)); + //g_message("## uvt:%.3f %.3f %.3f %.3f", UVt(0,0), UVt(0,1), UVt(1,0), UVt(1,1)); + rotate = UVt(0,0); +} + + + +static void gatherText(Inkscape::XML::Node *node, Glib::ustring &buf) { - if ( !name || strcmp(node->name(), name) == 0 ) + if (node->type() == Inkscape::XML::TEXT_NODE) { - results.push_back(node); + char *s = (char *)node->content(); + if (s) + buf.append(s); + } + + for (Inkscape::XML::Node *child = node->firstChild() ; + child != NULL; child = child->next()) + { + gatherText(child, buf); } - - for (Inkscape::XML::Node *child = node->firstChild() ; child ; child = child->next()) - findElementsByTagName( results, child, name ); } /** - * This function searches the Repr tree recursively from the given node, - * and adds refs to all nodes with the given name, to the result vector + * FIRST PASS. + * Method descends into the repr tree, converting image, style, and gradient info + * into forms compatible in ODF. */ void -OdfOutput::preprocess(Inkscape::XML::Node *node) -{ - //Look for style values in the svg element - Inkscape::Util::List attr = - node->attributeList(); - for ( ; attr ; ++attr) - { - DOMString attrName = (const char *)attr->key; - DOMString attrValue = (const char *)attr->value; - StyleInfo si(attrName, attrValue); - /* - if (styleTable.find(styleValue) != styleTable.end()) +OdfOutput::preprocess(ZipFile &zf, Inkscape::XML::Node *node) +{ + + Glib::ustring nodeName = node->name(); + Glib::ustring id = getAttribute(node, "id"); + + //### First, check for metadata + if (nodeName == "metadata" || nodeName == "svg:metadata") + { + Inkscape::XML::Node *mchild = node->firstChild() ; + if (!mchild || strcmp(mchild->name(), "rdf:RDF")) + return; + Inkscape::XML::Node *rchild = mchild->firstChild() ; + if (!rchild || strcmp(rchild->name(), "cc:Work")) + return; + for (Inkscape::XML::Node *cchild = rchild->firstChild() ; + cchild ; cchild = cchild->next()) { - g_message("duplicate style"); + Glib::ustring ccName = cchild->name(); + Glib::ustring ccVal; + gatherText(cchild, ccVal); + //g_message("ccName: %s ccVal:%s", ccName.c_str(), ccVal.c_str()); + metadata[ccName] = ccVal; } - else + return; + } + + //Now consider items. + SPObject *reprobj = SP_ACTIVE_DOCUMENT->getObjectByRepr(node); + if (!reprobj) + return; + if (!SP_IS_ITEM(reprobj)) + { + return; + } + SPItem *item = SP_ITEM(reprobj); + //### Get SVG-to-ODF transform + NR::Matrix tf = getODFTransform(item); + + if (nodeName == "image" || nodeName == "svg:image") + { + //g_message("image"); + Glib::ustring href = getAttribute(node, "xlink:href"); + if (href.size() > 0) { - char buf[16]; - snprintf(buf, 15, "style%d", styleIndex++); - std::string styleName = buf; - //Map from value-->name . Looks backwards, i know - styleTable[styleValue] = styleName; - g_message("mapping '%s' to '%s'", - styleValue.c_str(), styleName.c_str()); + Glib::ustring oldName = href; + Glib::ustring ext = getExtension(oldName); + if (ext == ".jpeg") + ext = ".jpg"; + if (imageTable.find(oldName) == imageTable.end()) + { + char buf[64]; + snprintf(buf, 63, "Pictures/image%d%s", + (int)imageTable.size(), ext.c_str()); + Glib::ustring newName = buf; + imageTable[oldName] = newName; + Glib::ustring comment = "old name was: "; + comment.append(oldName); + URI oldUri(oldName); + //g_message("oldpath:%s", oldUri.getNativePath().c_str()); + //# if relative to the documentURI, get proper path + URI resUri = documentUri.resolve(oldUri); + DOMString pathName = resUri.getNativePath(); + //g_message("native path:%s", pathName.c_str()); + ZipEntry *ze = zf.addFile(pathName, comment); + if (ze) + { + ze->setFileName(newName); + } + else + { + g_warning("Could not load image file '%s'", pathName.c_str()); + } + } } - */ } + //###### Get style + SPStyle *style = SP_OBJECT_STYLE(item); + if (style && id.size()>0) + { + bool isGradient = false; + + StyleInfo si; + //## Style. Look in writeStyle() below to see what info + // we need to read into StyleInfo. Note that we need to + // determine whether information goes into a style element + // or a gradient element. + //## FILL + if (style->fill.type == SP_PAINT_TYPE_COLOR) + { + guint32 fillCol = + sp_color_get_rgba32_ualpha(&style->fill.value.color, 0); + char buf[16]; + int r = (fillCol >> 24) & 0xff; + int g = (fillCol >> 16) & 0xff; + int b = (fillCol >> 8) & 0xff; + //g_message("## %s %lx", id.c_str(), (unsigned int)fillCol); + snprintf(buf, 15, "#%02x%02x%02x", r, g, b); + si.fillColor = buf; + si.fill = "solid"; + double opacityPercent = 100.0 * + (SP_SCALE24_TO_FLOAT(style->fill_opacity.value)); + snprintf(buf, 15, "%.3f%%", opacityPercent); + si.fillOpacity = buf; + } + else if (style->fill.type == SP_PAINT_TYPE_PAINTSERVER) + { + //## Gradient. Look in writeStyle() below to see what info + // we need to read into GradientInfo. + if (!SP_IS_GRADIENT(SP_STYLE_FILL_SERVER(style))) + return; + isGradient = true; + GradientInfo gi; + SPGradient *gradient = SP_GRADIENT(SP_STYLE_FILL_SERVER(style)); + if (SP_IS_LINEARGRADIENT(gradient)) + { + gi.style = "linear"; + SPLinearGradient *linGrad = SP_LINEARGRADIENT(gradient); + gi.x1 = linGrad->x1.value; + gi.y1 = linGrad->y1.value; + gi.x2 = linGrad->x2.value; + gi.y2 = linGrad->y2.value; + } + else if (SP_IS_RADIALGRADIENT(gradient)) + { + gi.style = "radial"; + SPRadialGradient *radGrad = SP_RADIALGRADIENT(gradient); + gi.cx = radGrad->cx.computed * 100.0;//ODG cx is percentages + gi.cy = radGrad->cy.computed * 100.0; + } + else + { + g_warning("not a supported gradient type"); + } + + //Look for existing identical style; + bool gradientMatch = false; + std::vector::iterator iter; + for (iter=gradientTable.begin() ; iter!=gradientTable.end() ; iter++) + { + if (gi.equals(*iter)) + { + //map to existing gradientTable entry + Glib::ustring gradientName = iter->name; + //g_message("found duplicate style:%s", gradientName.c_str()); + gradientLookupTable[id] = gradientName; + gradientMatch = true; + break; + } + } + //None found, make a new pair or entries + if (!gradientMatch) + { + char buf[16]; + snprintf(buf, 15, "gradient%d", (int)gradientTable.size()); + Glib::ustring gradientName = buf; + gi.name = gradientName; + gradientTable.push_back(gi); + gradientLookupTable[id] = gradientName; + } + } + + //## STROKE + if (style->stroke.type == SP_PAINT_TYPE_COLOR) + { + guint32 strokeCol = + sp_color_get_rgba32_ualpha(&style->stroke.value.color, 0); + char buf[16]; + int r = (strokeCol >> 24) & 0xff; + int g = (strokeCol >> 16) & 0xff; + int b = (strokeCol >> 8) & 0xff; + snprintf(buf, 15, "#%02x%02x%02x", r, g, b); + si.strokeColor = buf; + snprintf(buf, 15, "%.3fpt", style->stroke_width.value); + si.strokeWidth = buf; + si.stroke = "solid"; + double opacityPercent = 100.0 * + (SP_SCALE24_TO_FLOAT(style->stroke_opacity.value)); + snprintf(buf, 15, "%.3f%%", opacityPercent); + si.strokeOpacity = buf; + } + + if (!isGradient) + { + //Look for existing identical style; + bool styleMatch = false; + std::vector::iterator iter; + for (iter=styleTable.begin() ; iter!=styleTable.end() ; iter++) + { + if (si.equals(*iter)) + { + //map to existing styleTable entry + Glib::ustring styleName = iter->name; + //g_message("found duplicate style:%s", styleName.c_str()); + styleLookupTable[id] = styleName; + styleMatch = true; + break; + } + } + //None found, make a new pair or entries + if (!styleMatch) + { + char buf[16]; + snprintf(buf, 15, "style%d", (int)styleTable.size()); + Glib::ustring styleName = buf; + si.name = styleName; + styleTable.push_back(si); + styleLookupTable[id] = styleName; + } + } + } + for (Inkscape::XML::Node *child = node->firstChild() ; child ; child = child->next()) - preprocess(child); + preprocess(zf, child); } + /** - * This function searches the Repr tree recursively from the given node, - * and adds refs to all nodes with the given name, to the result vector + * Writes the manifest. Currently it only changes according to the + * file names of images packed into the zip file. */ -void -OdfOutput::preprocess(SPDocument *doc) +bool OdfOutput::writeManifest(ZipFile &zf) { - styleTable.clear(); - styleIndex = 0; - preprocess(doc->rroot); - - outs.clear(); - - po("\n"); - po("\n"); - po("\n"); - po("\n"); - po("\n"); - po("\n"); - po("\n"); - po("\n"); - po(" \n"); - po("\n"); - po("\n"); - po(" \n"); - po("\n"); - - //## Dump our style table + BufferOutputStream bouts; + OutputStreamWriter outs(bouts); + + time_t tim; + time(&tim); + + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf(" \n"); + outs.printf(" \n"); + outs.printf(" \n"); + outs.printf(" \n"); + std::map::iterator iter; + for (iter = imageTable.begin() ; iter!=imageTable.end() ; iter++) + { + Glib::ustring oldName = iter->first; + Glib::ustring newName = iter->second; + + Glib::ustring ext = getExtension(oldName); + if (ext == ".jpeg") + ext = ".jpg"; + outs.printf(" \n"); + } + outs.printf("\n"); + + outs.close(); + + //Make our entry + ZipEntry *ze = zf.newEntry("META-INF/manifest.xml", "ODF file manifest"); + ze->setUncompressedData(bouts.getBuffer()); + ze->finish(); + + return true; +} + + +/** + * This writes the document meta information to meta.xml + */ +bool OdfOutput::writeMeta(ZipFile &zf) +{ + BufferOutputStream bouts; + OutputStreamWriter outs(bouts); + + time_t tim; + time(&tim); + + std::map::iterator iter; + Glib::ustring creator = "unknown"; + iter = metadata.find("dc:creator"); + if (iter != metadata.end()) + creator = iter->second; + Glib::ustring date = ""; + iter = metadata.find("dc:date"); + if (iter != metadata.end()) + date = iter->second; + + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf(" Inkscape.org - 0.45\n"); + outs.printf(" %s\n", + toXml(creator).c_str()); + outs.printf(" %s\n", date.c_str()); + for (iter = metadata.begin() ; iter != metadata.end() ; iter++) + { + Glib::ustring name = iter->first; + Glib::ustring value = iter->second; + if (name.size() > 0 && value.size()>0) + { + outs.printf(" <%s>%s\n", + toXml(name).c_str(), toXml(value).c_str(), toXml(name).c_str()); + } + } + outs.printf(" 2\n"); + outs.printf(" PT56S\n"); + outs.printf(" \n"); + outs.printf(" \n"); + outs.printf(" \n"); + outs.printf(" \n"); + outs.printf(" \n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + + + outs.close(); + + //Make our entry + ZipEntry *ze = zf.newEntry("meta.xml", "ODF info file"); + ze->setUncompressedData(bouts.getBuffer()); + ze->finish(); + + return true; +} + + + + +/** + * This is called just before writeTree(), since it will write style and + * gradient information above the tag in the content.xml file + */ +bool OdfOutput::writeStyle(Writer &outs) +{ + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf(" \n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf(" \n"); + outs.printf("\n"); + /* - std::map::iterator iter; + ========================================================== + Dump our style table. Styles should have a general layout + something like the following. Look in: + http://books.evc-cit.info/odbook/ch06.html#draw-style-file-section + for style and gradient information. + + + + ========================================================== + */ + outs.printf("\n"); + std::vector::iterator iter; for (iter = styleTable.begin() ; iter != styleTable.end() ; iter++) { - po("second); - po(" style:family=\"graphic\" style:parent-style-name=\"standard\">\n"); - po(" name.c_str()); + StyleInfo s(*iter); + outs.printf(" style:family=\"graphic\" style:parent-style-name=\"standard\">\n"); + outs.printf(" \n"); - po("\n"); + outs.printf(" draw:stroke=\"%s\" ", s.stroke.c_str()); + if (s.stroke != "none") + { + outs.printf(" svg:stroke-width=\"%s\" ", s.strokeWidth.c_str()); + outs.printf(" svg:stroke-color=\"%s\" ", s.strokeColor.c_str()); + outs.printf(" svg:stroke-opacity=\"%s\" ", s.strokeOpacity.c_str()); + } + outs.printf("/>\n"); + outs.printf("\n"); + } + + //## Dump our gradient table + outs.printf("\n"); + outs.printf("\n"); + std::vector::iterator giter; + for (giter = gradientTable.begin() ; giter != gradientTable.end() ; giter++) + { + GradientInfo gi(*giter); + outs.printf(" + =================================================================== + */ + outs.printf("draw:display-name=\"linear borderless\" "); + } + else if (gi.style == "radial") + { + /* + =================================================================== + RADIAL gradient. We need something that looks like this: + + + =================================================================== + */ + outs.printf("draw:display-name=\"radial borderless\" "); + outs.printf("draw:cx=\".2f%%\" draw:cy=\".2f%%\" ", gi.cx, gi.cy); + } + else + { + g_warning("unsupported gradient style '%s'", gi.style.c_str()); + } + outs.printf("/>\n"); } - */ - po("\n"); - po("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + + return true; } -bool OdfOutput::writeTree(Inkscape::XML::Node *node) + +/** + * Writes an SVG path as an ODF + */ +static int +writePath(Writer &outs, NArtBpath const *bpath, + NR::Matrix &tf, double xoff, double yoff) +{ + bool closed = false; + int nrPoints = 0; + NArtBpath *bp = (NArtBpath *)bpath; + + double destx = 0.0; + double desty = 0.0; + int code = -1; + + for ( ; bp->code != NR_END; bp++) + { + code = bp->code; + + NR::Point const p1(bp->c(1) * tf); + NR::Point const p2(bp->c(2) * tf); + NR::Point const p3(bp->c(3) * tf); + double x1 = (p1[NR::X] - xoff) * 1000.0; + if (fabs(x1)<1.0) x1=0.0; + double y1 = (p1[NR::Y] - yoff) * 1000.0; + if (fabs(y1)<1.0) y1=0.0; + double x2 = (p2[NR::X] - xoff) * 1000.0; + if (fabs(x2)<1.0) x2=0.0; + double y2 = (p2[NR::Y] - yoff) * 1000.0; + if (fabs(y2)<1.0) y2=0.0; + double x3 = (p3[NR::X] - xoff) * 1000.0; + if (fabs(x3)<1.0) x3=0.0; + double y3 = (p3[NR::Y] - yoff) * 1000.0; + if (fabs(y3)<1.0) y3=0.0; + destx = x3; + desty = y3; + + switch (code) + { + case NR_LINETO: + outs.printf("L %.3f %.3f ", destx, desty); + break; + + case NR_CURVETO: + outs.printf("C %.3f %.3f %.3f %.3f %.3f %.3f ", + x1, y1, x2, y2, destx, desty); + break; + + case NR_MOVETO_OPEN: + case NR_MOVETO: + if (closed) + outs.printf("Z "); + closed = ( code == NR_MOVETO ); + outs.printf("M %.3f %.3f ", destx, desty); + break; + + default: + break; + + } + + nrPoints++; + } + + if (closed) + { + outs.printf("Z"); + } + + return nrPoints; +} + + + +/** + * SECOND PASS. + * This is the main SPObject tree output to ODF. preprocess() + * must be called prior to this, as elements will often reference + * data parsed and tabled in preprocess(). + */ +bool OdfOutput::writeTree(Writer &outs, Inkscape::XML::Node *node) { //# Get the SPItem, if applicable SPObject *reprobj = SP_ACTIVE_DOCUMENT->getObjectByRepr(node); @@ -337,31 +1645,376 @@ bool OdfOutput::writeTree(Inkscape::XML::Node *node) } SPItem *item = SP_ITEM(reprobj); + + Glib::ustring nodeName = node->name(); + Glib::ustring id = getAttribute(node, "id"); + + //### Get SVG-to-ODF transform + NR::Matrix tf = getODFTransform(item); + + //### Get ODF bounding box params for item + NR::Rect bbox = getODFBoundingBox(item); + double bbox_x = bbox.min()[NR::X]; + double bbox_y = bbox.min()[NR::Y]; + double bbox_width = bbox.max()[NR::X] - bbox.min()[NR::X]; + double bbox_height = bbox.max()[NR::Y] - bbox.min()[NR::Y]; + + double rotate; + double xskew; + double yskew; + double xscale; + double yscale; + analyzeTransform(tf, rotate, xskew, yskew, xscale, yscale); + //# Do our stuff + SPCurve *curve = NULL; + //g_message("##### %s #####", nodeName.c_str()); - //# Iterate through the children - for (Inkscape::XML::Node *child = node->firstChild() ; child ; child = child->next()) + if (nodeName == "svg" || nodeName == "svg:svg") + { + //# Iterate through the children + for (Inkscape::XML::Node *child = node->firstChild() ; child ; child = child->next()) + { + if (!writeTree(outs, child)) + return false; + } + return true; + } + else if (nodeName == "g" || nodeName == "svg:g") + { + if (id.size() > 0) + outs.printf("\n", id.c_str()); + else + outs.printf("\n"); + //# Iterate through the children + for (Inkscape::XML::Node *child = node->firstChild() ; child ; child = child->next()) + { + if (!writeTree(outs, child)) + return false; + } + if (id.size() > 0) + outs.printf(" \n", id.c_str()); + else + outs.printf("\n"); + return true; + } + else if (nodeName == "image" || nodeName == "svg:image") { - if (!writeTree(child)) + if (!SP_IS_IMAGE(item)) + { + g_warning(" is not an SPImage. Why? ;-)"); return false; + } + + SPImage *img = SP_IMAGE(item); + double ix = img->x.value; + double iy = img->y.value; + double iwidth = img->width.value; + double iheight = img->height.value; + + NR::Rect ibbox(NR::Point(ix, iy), NR::Point(ix+iwidth, iy+iheight)); + ibbox = ibbox * tf; + ix = ibbox.min()[NR::X]; + iy = ibbox.min()[NR::Y]; + //iwidth = ibbox.max()[NR::X] - ibbox.min()[NR::X]; + //iheight = ibbox.max()[NR::Y] - ibbox.min()[NR::Y]; + iwidth = xscale * iwidth; + iheight = yscale * iheight; + + NR::Matrix itemTransform = getODFItemTransform(item); + + Glib::ustring itemTransformString = formatTransform(itemTransform); + + Glib::ustring href = getAttribute(node, "xlink:href"); + std::map::iterator iter = imageTable.find(href); + if (iter == imageTable.end()) + { + g_warning("image '%s' not in table", href.c_str()); + return false; + } + Glib::ustring newName = iter->second; + + outs.printf(" 0) + outs.printf("id=\"%s\" ", id.c_str()); + outs.printf("draw:style-name=\"gr1\" draw:text-style-name=\"P1\" draw:layer=\"layout\" "); + //no x or y. make them the translate transform, last one + outs.printf("svg:width=\"%.3fcm\" svg:height=\"%.3fcm\" ", + iwidth, iheight); + if (itemTransformString.size() > 0) + { + outs.printf("draw:transform=\"%s translate(%.3fcm, %.3fcm)\" ", + itemTransformString.c_str(), ix, iy); + } + else + { + outs.printf("draw:transform=\"translate(%.3fcm, %.3fcm)\" ", + ix, iy); + } + + outs.printf(">\n"); + outs.printf(" \n"); + outs.printf(" \n"); + outs.printf(" \n"); + outs.printf("\n"); + return true; + } + else if (SP_IS_SHAPE(item)) + { + //g_message("### %s is a shape", nodeName.c_str()); + curve = sp_shape_get_curve(SP_SHAPE(item)); + } + else if (SP_IS_TEXT(item) || SP_IS_FLOWTEXT(item)) + { + curve = te_get_layout(item)->convertToCurves(); } + + if (curve) + { + //### Default output + + outs.printf("0) + outs.printf("id=\"%s\" ", id.c_str()); + + std::map::iterator siter; + siter = styleLookupTable.find(id); + if (siter != styleLookupTable.end()) + { + Glib::ustring styleName = siter->second; + outs.printf("draw:style-name=\"%s\" ", styleName.c_str()); + } + + std::map::iterator giter; + giter = gradientLookupTable.find(id); + if (giter != gradientLookupTable.end()) + { + Glib::ustring gradientName = giter->second; + outs.printf("draw:fill-gradient-name=\"%s\" ", + gradientName.c_str()); + } + + outs.printf("draw:layer=\"layout\" svg:x=\"%.3fcm\" svg:y=\"%.3fcm\" ", + bbox_x, bbox_y); + outs.printf("svg:width=\"%.3fcm\" svg:height=\"%.3fcm\" ", + bbox_width, bbox_height); + outs.printf("svg:viewBox=\"0.0 0.0 %.3f %.3f\"\n", + bbox_width * 1000.0, bbox_height * 1000.0); + + outs.printf(" svg:d=\""); + int nrPoints = writePath(outs, SP_CURVE_BPATH(curve), + tf, bbox_x, bbox_y); + outs.printf("\""); + + outs.printf(">\n"); + outs.printf(" \n", nrPoints); + outs.printf("\n\n"); + + + sp_curve_unref(curve); + } + return true; } +/** + * Write the content.xml file. Writes the namesspace headers, then + * calls writeStyle() and writeTree(). + */ +bool OdfOutput::writeContent(ZipFile &zf, Inkscape::XML::Node *node) +{ + BufferOutputStream bouts; + OutputStreamWriter outs(bouts); + + time_t tim; + time(&tim); + + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + + if (!writeStyle(outs)) + { + g_warning("Failed to write styles"); + return false; + } + + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + + if (!writeTree(outs, node)) + { + g_warning("Failed to convert SVG tree"); + return false; + } + + outs.printf("\n"); + outs.printf("\n"); + + outs.printf("\n"); + outs.printf("\n"); + + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + outs.printf("\n"); + + + + //Make our entry + ZipEntry *ze = zf.newEntry("content.xml", "ODF master content file"); + ze->setUncompressedData(bouts.getBuffer()); + ze->finish(); + + return true; +} + + +/** + * Resets class to its pristine condition, ready to use again + */ +void +OdfOutput::reset() +{ + metadata.clear(); + styleTable.clear(); + styleLookupTable.clear(); + gradientTable.clear(); + gradientLookupTable.clear(); + imageTable.clear(); + + +} + + /** * Descends into the SVG tree, mapping things to ODF when appropriate */ void OdfOutput::save(Inkscape::Extension::Output *mod, SPDocument *doc, gchar const *uri) { - //# Preprocess the style entries. ODF does not put styles - //# directly on elements. Rather, it uses class IDs. - preprocess(doc); - ZipFile zipFile; - zipFile.writeFile(uri); + reset(); + + //g_message("native file:%s\n", uri); + documentUri = URI(uri); + + ZipFile zf; + preprocess(zf, doc->rroot); + + if (!writeManifest(zf)) + { + g_warning("Failed to write manifest"); + return; + } + + if (!writeMeta(zf)) + { + g_warning("Failed to write metafile"); + return; + } + + if (!writeContent(zf, doc->rroot)) + { + g_warning("Failed to write content"); + return; + } + + if (!zf.writeFile(uri)) + { + return; + } } @@ -401,18 +2054,39 @@ OdfOutput::check (Inkscape::Extension::Extension *module) return TRUE; } + + //######################################################################## //# I N P U T //######################################################################## +//####################### +//# L A T E R !!! :-) +//####################### + + + + + + + + + + + + } //namespace Internal } //namespace Extension } //namespace Inkscape +//######################################################################## +//# E N D O F F I L E +//######################################################################## + /* Local Variables: mode:c++