Code

Line-end fix
authorjoncruz <joncruz@users.sourceforge.net>
Mon, 25 Feb 2008 05:29:06 +0000 (05:29 +0000)
committerjoncruz <joncruz@users.sourceforge.net>
Mon, 25 Feb 2008 05:29:06 +0000 (05:29 +0000)
src/2geom/angle.h
src/2geom/poly-dk-solve.cpp
src/2geom/poly-laguerre-solve.cpp
src/2geom/sweep.cpp
src/helper/pixbuf-ops.h
src/libnr/nr-convert2geom.h
src/ui/dialog/filedialogimpl-win32.cpp
src/ui/dialog/filedialogimpl-win32.h

index 4d548ab49b5750a1a5c6a72e514efd5d852c83ab..05364fb222b57187767315b83223c0c41d3a8c80 100644 (file)
@@ -1,50 +1,50 @@
-/**\r
- *  \file angle.h\r
- *  \brief Various trigoniometric helper functions\r
- *\r
- *  Authors:\r
- *   Johan Engelen <goejendaagh@zonnet.nl>\r
- *\r
- * Copyright (C) 2007 authors\r
- *\r
- * This library is free software; you can redistribute it and/or\r
- * modify it either under the terms of the GNU Lesser General Public\r
- * License version 2.1 as published by the Free Software Foundation\r
- * (the "LGPL") or, at your option, under the terms of the Mozilla\r
- * Public License Version 1.1 (the "MPL"). If you do not alter this\r
- * notice, a recipient may use your version of this file under either\r
- * the MPL or the LGPL.\r
- *\r
- * You should have received a copy of the LGPL along with this library\r
- * in the file COPYING-LGPL-2.1; if not, write to the Free Software\r
- * Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA 02111-1307 USA\r
- * You should have received a copy of the MPL along with this library\r
- * in the file COPYING-MPL-1.1\r
- *\r
- * The contents of this file are subject to the Mozilla Public License\r
- * Version 1.1 (the "License"); you may not use this file except in\r
- * compliance with the License. You may obtain a copy of the License at\r
- * http://www.mozilla.org/MPL/\r
- *\r
- * This software is distributed on an "AS IS" basis, WITHOUT WARRANTY\r
- * OF ANY KIND, either express or implied. See the LGPL or the MPL for\r
- * the specific language governing rights and limitations.\r
- *\r
- */\r
\r
-#ifndef LIB2GEOM_SEEN_ANGLE_H\r
-#define LIB2GEOM_SEEN_ANGLE_H\r
-\r
-namespace Geom {\r
-\r
-#ifndef M_PI\r
-# define M_PI 3.14159265358979323846\r
-#endif\r
-\r
-inline double deg_to_rad(double deg) { return deg*M_PI/180.0;}\r
-\r
-inline double rad_to_deg(double rad) { return rad*180.0/M_PI;}\r
-\r
-}\r
-\r
-#endif\r
+/**
+ *  \file angle.h
+ *  \brief Various trigoniometric helper functions
+ *
+ *  Authors:
+ *   Johan Engelen <goejendaagh@zonnet.nl>
+ *
+ * Copyright (C) 2007 authors
+ *
+ * This library is free software; you can redistribute it and/or
+ * modify it either under the terms of the GNU Lesser General Public
+ * License version 2.1 as published by the Free Software Foundation
+ * (the "LGPL") or, at your option, under the terms of the Mozilla
+ * Public License Version 1.1 (the "MPL"). If you do not alter this
+ * notice, a recipient may use your version of this file under either
+ * the MPL or the LGPL.
+ *
+ * You should have received a copy of the LGPL along with this library
+ * in the file COPYING-LGPL-2.1; if not, write to the Free Software
+ * Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA 02111-1307 USA
+ * You should have received a copy of the MPL along with this library
+ * in the file COPYING-MPL-1.1
+ *
+ * The contents of this file are subject to the Mozilla Public License
+ * Version 1.1 (the "License"); you may not use this file except in
+ * compliance with the License. You may obtain a copy of the License at
+ * http://www.mozilla.org/MPL/
+ *
+ * This software is distributed on an "AS IS" basis, WITHOUT WARRANTY
+ * OF ANY KIND, either express or implied. See the LGPL or the MPL for
+ * the specific language governing rights and limitations.
+ *
+ */
+
+#ifndef LIB2GEOM_SEEN_ANGLE_H
+#define LIB2GEOM_SEEN_ANGLE_H
+
+namespace Geom {
+
+#ifndef M_PI
+# define M_PI 3.14159265358979323846
+#endif
+
+inline double deg_to_rad(double deg) { return deg*M_PI/180.0;}
+
+inline double rad_to_deg(double rad) { return rad*180.0/M_PI;}
+
+}
+
+#endif
index 87d238f14294c2692924ec7b9d1c97d53e19807d..fdc1cefe55a585d2205a63fcf925b1a74a587058 100644 (file)
@@ -1,64 +1,64 @@
-#include "poly-dk-solve.h"\r
-#include <iterator>\r
-\r
-/*** implementation of the Durand-Kerner method.  seems buggy*/\r
-\r
-std::complex<double> evalu(Poly const & p, std::complex<double> x) {\r
-    std::complex<double> result = 0;\r
-    std::complex<double> xx = 1;\r
-\r
-    for(unsigned i = 0; i < p.size(); i++) {\r
-        result += p[i]*xx;\r
-        xx *= x;\r
-    }\r
-    return result;\r
-}\r
-\r
-std::vector<std::complex<double> > DK(Poly const & ply, const double tol) {\r
-    std::vector<std::complex<double> > roots;\r
-    const int N = ply.degree();\r
-\r
-    std::complex<double> b(0.4, 0.9);\r
-    std::complex<double> p = 1;\r
-    for(int i = 0; i < N; i++) {\r
-        roots.push_back(p);\r
-        p *= b;\r
-    }\r
-    assert(roots.size() == ply.degree());\r
-\r
-    double error = 0;\r
-    int i;\r
-    for( i = 0; i < 30; i++) {\r
-        error = 0;\r
-        for(int r_i = 0; r_i < N; r_i++) {\r
-            std::complex<double> denom = 1;\r
-            std::complex<double> R = roots[r_i];\r
-            for(int d_i = 0; d_i < N; d_i++) {\r
-                if(r_i != d_i)\r
-                    denom *= R-roots[d_i];\r
-            }\r
-            assert(norm(denom) != 0);\r
-            std::complex<double> dr = evalu(ply, R)/denom;\r
-            error += norm(dr);\r
-            roots[r_i] = R - dr;\r
-        }\r
-        /*std::copy(roots.begin(), roots.end(), std::ostream_iterator<std::complex<double> >(std::cout, ",\t"));\r
-          std::cout << std::endl;*/\r
-        if(error < tol)\r
-            break;\r
-    }\r
-    //std::cout << error << ", " << i<< std::endl;\r
-    return roots;\r
-}\r
-\r
-\r
-/*\r
-  Local Variables:\r
-  mode:c++\r
-  c-file-style:"stroustrup"\r
-  c-file-offsets:((innamespace . 0)(inline-open . 0)(case-label . +))\r
-  indent-tabs-mode:nil\r
-  fill-column:99\r
-  End:\r
-*/\r
-// vim: filetype=cpp:expandtab:shiftwidth=4:tabstop=8:softtabstop=4:encoding=utf-8:textwidth=99 :\r
+#include "poly-dk-solve.h"
+#include <iterator>
+
+/*** implementation of the Durand-Kerner method.  seems buggy*/
+
+std::complex<double> evalu(Poly const & p, std::complex<double> x) {
+    std::complex<double> result = 0;
+    std::complex<double> xx = 1;
+
+    for(unsigned i = 0; i < p.size(); i++) {
+        result += p[i]*xx;
+        xx *= x;
+    }
+    return result;
+}
+
+std::vector<std::complex<double> > DK(Poly const & ply, const double tol) {
+    std::vector<std::complex<double> > roots;
+    const int N = ply.degree();
+
+    std::complex<double> b(0.4, 0.9);
+    std::complex<double> p = 1;
+    for(int i = 0; i < N; i++) {
+        roots.push_back(p);
+        p *= b;
+    }
+    assert(roots.size() == ply.degree());
+
+    double error = 0;
+    int i;
+    for( i = 0; i < 30; i++) {
+        error = 0;
+        for(int r_i = 0; r_i < N; r_i++) {
+            std::complex<double> denom = 1;
+            std::complex<double> R = roots[r_i];
+            for(int d_i = 0; d_i < N; d_i++) {
+                if(r_i != d_i)
+                    denom *= R-roots[d_i];
+            }
+            assert(norm(denom) != 0);
+            std::complex<double> dr = evalu(ply, R)/denom;
+            error += norm(dr);
+            roots[r_i] = R - dr;
+        }
+        /*std::copy(roots.begin(), roots.end(), std::ostream_iterator<std::complex<double> >(std::cout, ",\t"));
+          std::cout << std::endl;*/
+        if(error < tol)
+            break;
+    }
+    //std::cout << error << ", " << i<< std::endl;
+    return roots;
+}
+
+
+/*
+  Local Variables:
+  mode:c++
+  c-file-style:"stroustrup"
+  c-file-offsets:((innamespace . 0)(inline-open . 0)(case-label . +))
+  indent-tabs-mode:nil
+  fill-column:99
+  End:
+*/
+// vim: filetype=cpp:expandtab:shiftwidth=4:tabstop=8:softtabstop=4:encoding=utf-8:textwidth=99 :
index 921ec3e3b36ae81112929dfd5f986cd214c4bd3a..766f16edafa1e2621e9d7e24bfa0c3da9cb2f3a1 100644 (file)
-#include "poly-laguerre-solve.h"\r
-#include <iterator>\r
-\r
-typedef std::complex<double> cdouble;\r
-\r
-cdouble laguerre_internal_complex(Poly const & p,\r
-                                  double x0,\r
-                                  double tol,\r
-                                  bool & quad_root) {\r
-    cdouble a = 2*tol;\r
-    cdouble xk = x0;\r
-    double n = p.degree();\r
-    quad_root = false;\r
-    const unsigned shuffle_rate = 10;\r
-    static double shuffle[] = {0, 0.5, 0.25, 0.75, 0.125, 0.375, 0.625, 0.875, 1.0};\r
-    unsigned shuffle_counter = 0;\r
-    while(std::norm(a) > (tol*tol)) {\r
-        //std::cout << "xk = " << xk << std::endl;\r
-        cdouble b = p.back();\r
-        cdouble d = 0, f = 0;\r
-        double err = abs(b);\r
-        double abx = abs(xk);\r
-        for(int j = p.size()-2; j >= 0; j--) {\r
-            f = xk*f + d;\r
-            d = xk*d + b;\r
-            b = xk*b + p[j];\r
-            err = abs(b) + abx*err;\r
-        }\r
-\r
-        err *= 1e-7; // magic epsilon for convergence, should be computed from tol\r
-\r
-        cdouble px = b;\r
-        if(abs(b) < err)\r
-            return xk;\r
-        //if(std::norm(px) < tol*tol)\r
-        //    return xk;\r
-        cdouble G = d / px;\r
-        cdouble H = G*G - f / px;\r
-\r
-        //std::cout << "G = " << G << "H = " << H;\r
-        cdouble radicand = (n - 1)*(n*H-G*G);\r
-        //assert(radicand.real() > 0);\r
-        if(radicand.real() < 0)\r
-            quad_root = true;\r
-        //std::cout << "radicand = " << radicand << std::endl;\r
-        if(G.real() < 0) // here we try to maximise the denominator avoiding cancellation\r
-            a = - sqrt(radicand);\r
-        else\r
-            a = sqrt(radicand);\r
-        //std::cout << "a = " << a << std::endl;\r
-        a = n / (a + G);\r
-        //std::cout << "a = " << a << std::endl;\r
-        if(shuffle_counter % shuffle_rate == 0)\r
-            ;//a *= shuffle[shuffle_counter / shuffle_rate];\r
-        xk -= a;\r
-        shuffle_counter++;\r
-        if(shuffle_counter >= 90)\r
-            break;\r
-    }\r
-    //std::cout << "xk = " << xk << std::endl;\r
-    return xk;\r
-}\r
-\r
-double laguerre_internal(Poly const & p,\r
-                         Poly const & pp,\r
-                         Poly const & ppp,\r
-                         double x0,\r
-                         double tol,\r
-                         bool & quad_root) {\r
-    double a = 2*tol;\r
-    double xk = x0;\r
-    double n = p.degree();\r
-    quad_root = false;\r
-    while(a*a > (tol*tol)) {\r
-        //std::cout << "xk = " << xk << std::endl;\r
-        double px = p(xk);\r
-        if(px*px < tol*tol)\r
-            return xk;\r
-        double G = pp(xk) / px;\r
-        double H = G*G - ppp(xk) / px;\r
-\r
-        //std::cout << "G = " << G << "H = " << H;\r
-        double radicand = (n - 1)*(n*H-G*G);\r
-        assert(radicand > 0);\r
-        //std::cout << "radicand = " << radicand << std::endl;\r
-        if(G < 0) // here we try to maximise the denominator avoiding cancellation\r
-            a = - sqrt(radicand);\r
-        else\r
-            a = sqrt(radicand);\r
-        //std::cout << "a = " << a << std::endl;\r
-        a = n / (a + G);\r
-        //std::cout << "a = " << a << std::endl;\r
-        xk -= a;\r
-    }\r
-    //std::cout << "xk = " << xk << std::endl;\r
-    return xk;\r
-}\r
-\r
-\r
-std::vector<cdouble >\r
-laguerre(Poly p, const double tol) {\r
-    std::vector<cdouble > solutions;\r
-    //std::cout << "p = " << p << " = ";\r
-    while(p.size() > 1)\r
-    {\r
-        double x0 = 0;\r
-        bool quad_root = false;\r
-        cdouble sol = laguerre_internal_complex(p, x0, tol, quad_root);\r
-        //if(abs(sol) > 1) break;\r
-        Poly dvs;\r
-        if(quad_root) {\r
-            dvs.push_back((sol*conj(sol)).real());\r
-            dvs.push_back(-(sol + conj(sol)).real());\r
-            dvs.push_back(1.0);\r
-            //std::cout << "(" <<  dvs << ")";\r
-            //solutions.push_back(sol);\r
-            //solutions.push_back(conj(sol));\r
-        } else {\r
-            //std::cout << sol << std::endl;\r
-            dvs.push_back(-sol.real());\r
-            dvs.push_back(1.0);\r
-            solutions.push_back(sol);\r
-            //std::cout << "(" <<  dvs << ")";\r
-        }\r
-        Poly r;\r
-        p = divide(p, dvs, r);\r
-        //std::cout << r << std::endl;\r
-    }\r
-    return solutions;\r
-}\r
-\r
-std::vector<double>\r
-laguerre_real_interval(Poly const & ply,\r
-                       const double lo, const double hi,\r
-                       const double tol) {\r
-}\r
-\r
-/*\r
-  Local Variables:\r
-  mode:c++\r
-  c-file-style:"stroustrup"\r
-  c-file-offsets:((innamespace . 0)(inline-open . 0)(case-label . +))\r
-  indent-tabs-mode:nil\r
-  fill-column:99\r
-  End:\r
-*/\r
-// vim: filetype=cpp:expandtab:shiftwidth=4:tabstop=8:softtabstop=4:encoding=utf-8:textwidth=99 :\r
+#include "poly-laguerre-solve.h"
+#include <iterator>
+
+typedef std::complex<double> cdouble;
+
+cdouble laguerre_internal_complex(Poly const & p,
+                                  double x0,
+                                  double tol,
+                                  bool & quad_root) {
+    cdouble a = 2*tol;
+    cdouble xk = x0;
+    double n = p.degree();
+    quad_root = false;
+    const unsigned shuffle_rate = 10;
+    static double shuffle[] = {0, 0.5, 0.25, 0.75, 0.125, 0.375, 0.625, 0.875, 1.0};
+    unsigned shuffle_counter = 0;
+    while(std::norm(a) > (tol*tol)) {
+        //std::cout << "xk = " << xk << std::endl;
+        cdouble b = p.back();
+        cdouble d = 0, f = 0;
+        double err = abs(b);
+        double abx = abs(xk);
+        for(int j = p.size()-2; j >= 0; j--) {
+            f = xk*f + d;
+            d = xk*d + b;
+            b = xk*b + p[j];
+            err = abs(b) + abx*err;
+        }
+
+        err *= 1e-7; // magic epsilon for convergence, should be computed from tol
+
+        cdouble px = b;
+        if(abs(b) < err)
+            return xk;
+        //if(std::norm(px) < tol*tol)
+        //    return xk;
+        cdouble G = d / px;
+        cdouble H = G*G - f / px;
+
+        //std::cout << "G = " << G << "H = " << H;
+        cdouble radicand = (n - 1)*(n*H-G*G);
+        //assert(radicand.real() > 0);
+        if(radicand.real() < 0)
+            quad_root = true;
+        //std::cout << "radicand = " << radicand << std::endl;
+        if(G.real() < 0) // here we try to maximise the denominator avoiding cancellation
+            a = - sqrt(radicand);
+        else
+            a = sqrt(radicand);
+        //std::cout << "a = " << a << std::endl;
+        a = n / (a + G);
+        //std::cout << "a = " << a << std::endl;
+        if(shuffle_counter % shuffle_rate == 0)
+            ;//a *= shuffle[shuffle_counter / shuffle_rate];
+        xk -= a;
+        shuffle_counter++;
+        if(shuffle_counter >= 90)
+            break;
+    }
+    //std::cout << "xk = " << xk << std::endl;
+    return xk;
+}
+
+double laguerre_internal(Poly const & p,
+                         Poly const & pp,
+                         Poly const & ppp,
+                         double x0,
+                         double tol,
+                         bool & quad_root) {
+    double a = 2*tol;
+    double xk = x0;
+    double n = p.degree();
+    quad_root = false;
+    while(a*a > (tol*tol)) {
+        //std::cout << "xk = " << xk << std::endl;
+        double px = p(xk);
+        if(px*px < tol*tol)
+            return xk;
+        double G = pp(xk) / px;
+        double H = G*G - ppp(xk) / px;
+
+        //std::cout << "G = " << G << "H = " << H;
+        double radicand = (n - 1)*(n*H-G*G);
+        assert(radicand > 0);
+        //std::cout << "radicand = " << radicand << std::endl;
+        if(G < 0) // here we try to maximise the denominator avoiding cancellation
+            a = - sqrt(radicand);
+        else
+            a = sqrt(radicand);
+        //std::cout << "a = " << a << std::endl;
+        a = n / (a + G);
+        //std::cout << "a = " << a << std::endl;
+        xk -= a;
+    }
+    //std::cout << "xk = " << xk << std::endl;
+    return xk;
+}
+
+
+std::vector<cdouble >
+laguerre(Poly p, const double tol) {
+    std::vector<cdouble > solutions;
+    //std::cout << "p = " << p << " = ";
+    while(p.size() > 1)
+    {
+        double x0 = 0;
+        bool quad_root = false;
+        cdouble sol = laguerre_internal_complex(p, x0, tol, quad_root);
+        //if(abs(sol) > 1) break;
+        Poly dvs;
+        if(quad_root) {
+            dvs.push_back((sol*conj(sol)).real());
+            dvs.push_back(-(sol + conj(sol)).real());
+            dvs.push_back(1.0);
+            //std::cout << "(" <<  dvs << ")";
+            //solutions.push_back(sol);
+            //solutions.push_back(conj(sol));
+        } else {
+            //std::cout << sol << std::endl;
+            dvs.push_back(-sol.real());
+            dvs.push_back(1.0);
+            solutions.push_back(sol);
+            //std::cout << "(" <<  dvs << ")";
+        }
+        Poly r;
+        p = divide(p, dvs, r);
+        //std::cout << r << std::endl;
+    }
+    return solutions;
+}
+
+std::vector<double>
+laguerre_real_interval(Poly const & ply,
+                       const double lo, const double hi,
+                       const double tol) {
+}
+
+/*
+  Local Variables:
+  mode:c++
+  c-file-style:"stroustrup"
+  c-file-offsets:((innamespace . 0)(inline-open . 0)(case-label . +))
+  indent-tabs-mode:nil
+  fill-column:99
+  End:
+*/
+// vim: filetype=cpp:expandtab:shiftwidth=4:tabstop=8:softtabstop=4:encoding=utf-8:textwidth=99 :
index 96104ea90f9fce8927d1a4018c21bbf1849051b9..08674ab2fa872395a2c69da985b4e101a018e4d0 100644 (file)
-#include "sweep.h"\r
-\r
-#include <algorithm>\r
-\r
-namespace Geom {\r
-\r
-std::vector<std::vector<unsigned> > sweep_bounds(std::vector<Rect> rs) {\r
-    std::vector<Event> events; events.reserve(rs.size()*2);\r
-    std::vector<std::vector<unsigned> > pairs(rs.size());\r
-\r
-    for(unsigned i = 0; i < rs.size(); i++) {\r
-        events.push_back(Event(rs[i].left(), i, false));\r
-        events.push_back(Event(rs[i].right(), i, true));\r
-    }\r
-    std::sort(events.begin(), events.end());\r
-\r
-    std::vector<unsigned> open;\r
-    for(unsigned i = 0; i < events.size(); i++) {\r
-        unsigned ix = events[i].ix;\r
-        if(events[i].closing) {\r
-            std::vector<unsigned>::iterator iter = std::find(open.begin(), open.end(), ix);\r
-            //if(iter != open.end())\r
-            open.erase(iter);\r
-        } else {\r
-            for(unsigned j = 0; j < open.size(); j++) {\r
-                unsigned jx = open[j];\r
-                if(rs[jx][Y].intersects(rs[ix][Y])) {\r
-                    pairs[jx].push_back(ix);\r
-                }\r
-            }\r
-            open.push_back(ix);\r
-        }\r
-    }\r
-    return pairs;\r
-}\r
-\r
-std::vector<std::vector<unsigned> > sweep_bounds(std::vector<Rect> a, std::vector<Rect> b) {\r
-    std::vector<std::vector<unsigned> > pairs(a.size());\r
-    if(a.empty() || b.empty()) return pairs;\r
-    std::vector<Event> events[2];\r
-    events[0].reserve(a.size()*2);\r
-    events[1].reserve(b.size()*2);\r
-\r
-    for(unsigned n = 0; n < 2; n++) {\r
-        unsigned sz = n ? b.size() : a.size();\r
-        events[n].reserve(sz*2);\r
-        for(unsigned i = 0; i < sz; i++) {\r
-            events[n].push_back(Event(n ? b[i].left() : a[i].left(), i, false));\r
-            events[n].push_back(Event(n ? b[i].right() : a[i].right(), i, true));\r
-        }\r
-        std::sort(events[n].begin(), events[n].end());\r
-    }\r
-\r
-    std::vector<unsigned> open[2];\r
-    bool n = events[1].front() < events[0].front();\r
-    for(unsigned i[] = {0,0}; i[n] < events[n].size();) {\r
-        unsigned ix = events[n][i[n]].ix;\r
-        bool closing = events[n][i[n]].closing;\r
-        //std::cout << n << "[" << ix << "] - " << (closing ? "closer" : "opener") << "\n";\r
-        if(closing) {\r
-            open[n].erase(std::find(open[n].begin(), open[n].end(), ix));\r
-        } else {\r
-            if(n) {\r
-                //n = 1\r
-                //opening a B, add to all open a\r
-                for(unsigned j = 0; j < open[0].size(); j++) {\r
-                    unsigned jx = open[0][j];\r
-                    if(a[jx][Y].intersects(b[ix][Y])) {\r
-                        pairs[jx].push_back(ix);\r
-                    }\r
-                }\r
-            } else {\r
-                //n = 0\r
-                //opening an A, add all open b\r
-                for(unsigned j = 0; j < open[1].size(); j++) {\r
-                    unsigned jx = open[1][j];\r
-                    if(b[jx][Y].intersects(a[ix][Y])) {\r
-                        pairs[ix].push_back(jx);\r
-                    }\r
-                }\r
-            }\r
-            open[n].push_back(ix);\r
-        }\r
-        i[n]++;\r
-        n = (events[!n][i[!n]] < events[n][i[n]]) ? !n : n;\r
-    }\r
-    return pairs;\r
-}\r
-\r
-//Fake cull, until the switch to the real sweep is made.\r
-std::vector<std::vector<unsigned> > fake_cull(unsigned a, unsigned b) {\r
-    std::vector<std::vector<unsigned> > ret;\r
-\r
-    std::vector<unsigned> all;\r
-    for(unsigned j = 0; j < b; j++)\r
-        all.push_back(j);\r
-\r
-    for(unsigned i = 0; i < a; i++)\r
-        ret.push_back(all);\r
-\r
-    return ret;\r
-}\r
-\r
-}\r
+#include "sweep.h"
+
+#include <algorithm>
+
+namespace Geom {
+
+std::vector<std::vector<unsigned> > sweep_bounds(std::vector<Rect> rs) {
+    std::vector<Event> events; events.reserve(rs.size()*2);
+    std::vector<std::vector<unsigned> > pairs(rs.size());
+
+    for(unsigned i = 0; i < rs.size(); i++) {
+        events.push_back(Event(rs[i].left(), i, false));
+        events.push_back(Event(rs[i].right(), i, true));
+    }
+    std::sort(events.begin(), events.end());
+
+    std::vector<unsigned> open;
+    for(unsigned i = 0; i < events.size(); i++) {
+        unsigned ix = events[i].ix;
+        if(events[i].closing) {
+            std::vector<unsigned>::iterator iter = std::find(open.begin(), open.end(), ix);
+            //if(iter != open.end())
+            open.erase(iter);
+        } else {
+            for(unsigned j = 0; j < open.size(); j++) {
+                unsigned jx = open[j];
+                if(rs[jx][Y].intersects(rs[ix][Y])) {
+                    pairs[jx].push_back(ix);
+                }
+            }
+            open.push_back(ix);
+        }
+    }
+    return pairs;
+}
+
+std::vector<std::vector<unsigned> > sweep_bounds(std::vector<Rect> a, std::vector<Rect> b) {
+    std::vector<std::vector<unsigned> > pairs(a.size());
+    if(a.empty() || b.empty()) return pairs;
+    std::vector<Event> events[2];
+    events[0].reserve(a.size()*2);
+    events[1].reserve(b.size()*2);
+
+    for(unsigned n = 0; n < 2; n++) {
+        unsigned sz = n ? b.size() : a.size();
+        events[n].reserve(sz*2);
+        for(unsigned i = 0; i < sz; i++) {
+            events[n].push_back(Event(n ? b[i].left() : a[i].left(), i, false));
+            events[n].push_back(Event(n ? b[i].right() : a[i].right(), i, true));
+        }
+        std::sort(events[n].begin(), events[n].end());
+    }
+
+    std::vector<unsigned> open[2];
+    bool n = events[1].front() < events[0].front();
+    for(unsigned i[] = {0,0}; i[n] < events[n].size();) {
+        unsigned ix = events[n][i[n]].ix;
+        bool closing = events[n][i[n]].closing;
+        //std::cout << n << "[" << ix << "] - " << (closing ? "closer" : "opener") << "\n";
+        if(closing) {
+            open[n].erase(std::find(open[n].begin(), open[n].end(), ix));
+        } else {
+            if(n) {
+                //n = 1
+                //opening a B, add to all open a
+                for(unsigned j = 0; j < open[0].size(); j++) {
+                    unsigned jx = open[0][j];
+                    if(a[jx][Y].intersects(b[ix][Y])) {
+                        pairs[jx].push_back(ix);
+                    }
+                }
+            } else {
+                //n = 0
+                //opening an A, add all open b
+                for(unsigned j = 0; j < open[1].size(); j++) {
+                    unsigned jx = open[1][j];
+                    if(b[jx][Y].intersects(a[ix][Y])) {
+                        pairs[ix].push_back(jx);
+                    }
+                }
+            }
+            open[n].push_back(ix);
+        }
+        i[n]++;
+        n = (events[!n][i[!n]] < events[n][i[n]]) ? !n : n;
+    }
+    return pairs;
+}
+
+//Fake cull, until the switch to the real sweep is made.
+std::vector<std::vector<unsigned> > fake_cull(unsigned a, unsigned b) {
+    std::vector<std::vector<unsigned> > ret;
+
+    std::vector<unsigned> all;
+    for(unsigned j = 0; j < b; j++)
+        all.push_back(j);
+
+    for(unsigned i = 0; i < a; i++)
+        ret.push_back(all);
+
+    return ret;
+}
+
+}
index d87f4fa253374c2718ad74f74bef945c276e911b..a985be297eeaaa2d1de9ab622efe7c2f23ad922e 100644 (file)
@@ -1,27 +1,27 @@
-#ifndef __SP_PIXBUF_OPS_H__\r
-#define __SP_PIXBUF_OPS_H__\r
-\r
-/*\r
- * Helpers for SPItem -> gdk_pixbuf related stuff\r
- *\r
- * Authors:\r
- *   John Cliff <simarilius@yahoo.com>\r
- *\r
- * Copyright (C) 2008 John Cliff\r
- *\r
- * Released under GNU GPL, read the file 'COPYING' for more information\r
- */\r
-\r
+#ifndef __SP_PIXBUF_OPS_H__
+#define __SP_PIXBUF_OPS_H__
+
+/*
+ * Helpers for SPItem -> gdk_pixbuf related stuff
+ *
+ * Authors:
+ *   John Cliff <simarilius@yahoo.com>
+ *
+ * Copyright (C) 2008 John Cliff
+ *
+ * Released under GNU GPL, read the file 'COPYING' for more information
+ */
+
 #include <glib/gtypes.h>
 
-struct SPDocument;\r
-\r
-bool sp_export_jpg_file (SPDocument *doc, gchar const *filename, double x0, double y0, double x1, double y1,\r
-             unsigned int width, unsigned int height, double xdpi, double ydpi, unsigned long bgcolor, double quality, GSList *items_only = NULL);\r
-\r
-GdkPixbuf* sp_generate_internal_bitmap(SPDocument *doc, gchar const *filename,\r
-                   double x0, double y0, double x1, double y1,\r
-                   unsigned width, unsigned height, double xdpi, double ydpi,\r
-                   unsigned long bgcolor, GSList *items_only = NULL);\r
-\r
-#endif\r
+struct SPDocument;
+
+bool sp_export_jpg_file (SPDocument *doc, gchar const *filename, double x0, double y0, double x1, double y1,
+             unsigned int width, unsigned int height, double xdpi, double ydpi, unsigned long bgcolor, double quality, GSList *items_only = NULL);
+
+GdkPixbuf* sp_generate_internal_bitmap(SPDocument *doc, gchar const *filename,
+                   double x0, double y0, double x1, double y1,
+                   unsigned width, unsigned height, double xdpi, double ydpi,
+                   unsigned long bgcolor, GSList *items_only = NULL);
+
+#endif
index c9ae68bd127498c5fdbd1a8dab779a5b31025f41..7741e7782b8ff57aad00ec87bb891043c7cee912 100644 (file)
@@ -1,38 +1,38 @@
-#ifndef INKSCAPE_LIBNR_CONVERT2GEOM_H\r
-#define INKSCAPE_LIBNR_CONVERT2GEOM_H\r
-\r
-/*\r
- * Converts between NR and 2Geom types.\r
- *\r
-* Copyright (C) Johan Engelen 2008 <j.b.c.engelen@utwente.nl>\r
- *\r
- * Released under GNU GPL, read the file 'COPYING' for more information\r
- */\r
-\r
-#include <2geom/matrix.h>\r
-#include <libnr/nr-matrix.h>\r
-#include <2geom/d2.h>\r
-#include <libnr/nr-rect.h>\r
-\r
-inline Geom::Matrix to_2geom(NR::Matrix const & mat) {\r
-    Geom::Matrix mat2geom(mat[0], mat[1], mat[2], mat[3], mat[4], mat[5]);\r
-    return mat2geom;\r
-}\r
-\r
-inline NR::Rect from_2geom(Geom::Rect const & rect2geom) {\r
-    NR::Rect rect(rect2geom.min(), rect2geom.max());\r
-    return rect;\r
-}\r
-\r
-#endif\r
-\r
-/*\r
-  Local Variables:\r
-  mode:c++\r
-  c-file-style:"stroustrup"\r
-  c-file-offsets:((innamespace . 0)(inline-open . 0)(case-label . +))\r
-  indent-tabs-mode:nil\r
-  fill-column:99\r
-  End:\r
-*/\r
-// vim: filetype=cpp:expandtab:shiftwidth=4:tabstop=8:softtabstop=4:encoding=utf-8:textwidth=99 :\r
+#ifndef INKSCAPE_LIBNR_CONVERT2GEOM_H
+#define INKSCAPE_LIBNR_CONVERT2GEOM_H
+
+/*
+ * Converts between NR and 2Geom types.
+ *
+* Copyright (C) Johan Engelen 2008 <j.b.c.engelen@utwente.nl>
+ *
+ * Released under GNU GPL, read the file 'COPYING' for more information
+ */
+
+#include <2geom/matrix.h>
+#include <libnr/nr-matrix.h>
+#include <2geom/d2.h>
+#include <libnr/nr-rect.h>
+
+inline Geom::Matrix to_2geom(NR::Matrix const & mat) {
+    Geom::Matrix mat2geom(mat[0], mat[1], mat[2], mat[3], mat[4], mat[5]);
+    return mat2geom;
+}
+
+inline NR::Rect from_2geom(Geom::Rect const & rect2geom) {
+    NR::Rect rect(rect2geom.min(), rect2geom.max());
+    return rect;
+}
+
+#endif
+
+/*
+  Local Variables:
+  mode:c++
+  c-file-style:"stroustrup"
+  c-file-offsets:((innamespace . 0)(inline-open . 0)(case-label . +))
+  indent-tabs-mode:nil
+  fill-column:99
+  End:
+*/
+// vim: filetype=cpp:expandtab:shiftwidth=4:tabstop=8:softtabstop=4:encoding=utf-8:textwidth=99 :
index f67e12b877f9f9db0dad084477d04a02447a493f..e47154649abdf8476361843a3c538f9aa865f387 100644 (file)
-/**\r
- * Implementation of the file dialog interfaces defined in filedialog.h for Win32\r
- *\r
- * Authors:\r
- *   Joel Holdsworth\r
- *   The Inkscape Organization\r
- *\r
- * Copyright (C) 2004-2008 The Inkscape Organization\r
- *\r
- * Released under GNU GPL, read the file 'COPYING' for more information\r
- */\r
\r
-#ifdef HAVE_CONFIG_H\r
-# include <config.h>\r
-#endif\r
-\r
-#ifdef WIN32\r
\r
-//General includes\r
-#include <list>\r
-#include <unistd.h>\r
-#include <sys/stat.h>\r
-#include <errno.h>\r
-#include <set>\r
-#include <gdk/gdkwin32.h>\r
-#include <glib/gstdio.h>\r
-#include <glibmm/i18n.h>\r
-#include <gtkmm/window.h>\r
-\r
-//Inkscape includes\r
-#include "inkscape.h"\r
-#include "prefs-utils.h"\r
-#include <dialogs/dialog-events.h>\r
-#include <extension/input.h>\r
-#include <extension/output.h>\r
-#include <extension/db.h>\r
-\r
-#include <libnr/nr-pixops.h>\r
-#include <libnr/nr-translate-scale-ops.h>\r
-#include <display/nr-arena-item.h>\r
-#include <display/nr-arena.h>\r
-#include "sp-item.h"\r
-#include "canvas-arena.h"\r
-\r
-#include "filedialog.h"\r
-#include "filedialogimpl-win32.h"\r
-\r
-#include <zlib.h>\r
-#include <cairomm/win32_surface.h>\r
-#include <cairomm/context.h>\r
-\r
-using namespace std;\r
-using namespace Glib;\r
-using namespace Cairo;\r
-using namespace Gdk::Cairo;\r
-\r
-namespace Inkscape\r
-{\r
-namespace UI\r
-{\r
-namespace Dialog\r
-{\r
-\r
-const int PreviewWidening = 150;\r
-const char PreviewWindowClassName[] = "PreviewWnd";\r
-const unsigned long MaxPreviewFileSize = 1344; // kB\r
-\r
-#define IDC_SHOW_PREVIEW    1000\r
-\r
-// Windows 2000 version of OPENFILENAMEW\r
-struct OPENFILENAMEEXW : public OPENFILENAMEW { \r
-  void *        pvReserved;\r
-  DWORD         dwReserved;\r
-  DWORD         FlagsEx;\r
-};\r
-\r
-struct Filter\r
-{\r
-    gunichar2* name;\r
-    glong name_length;\r
-    gunichar2* filter;\r
-    glong filter_length;\r
-    Inkscape::Extension::Extension* mod;\r
-};\r
-\r
-ustring utf16_to_ustring(const wchar_t *utf16string, int utf16length = -1)\r
-{\r
-    gchar *utf8string = g_utf16_to_utf8((const gunichar2*)utf16string,\r
-        utf16length, NULL, NULL, NULL);\r
-    ustring result(utf8string);\r
-    g_free(utf8string);\r
-    \r
-    return result;\r
-}\r
-\r
-/*#########################################################################\r
-### F I L E     D I A L O G    B A S E    C L A S S\r
-#########################################################################*/\r
-\r
-FileDialogBaseWin32::FileDialogBaseWin32(Gtk::Window &parent, \r
-        const Glib::ustring &dir, const gchar *title,\r
-        FileDialogType type, gchar const* /*preferenceBase*/) :\r
-        dialogType(type),\r
-        parent(parent),\r
-        _current_directory(dir)\r
-{\r
-    //_mutex = NULL;\r
-    _main_loop = NULL;\r
-    \r
-    _title = (wchar_t*)g_utf8_to_utf16(title, -1, NULL, NULL, NULL);\r
-    \r
-    Glib::RefPtr<const Gdk::Window> parentWindow = parent.get_window();\r
-    g_assert(parentWindow->gobj() != NULL);\r
-    _ownerHwnd = (HWND)gdk_win32_drawable_get_handle((GdkDrawable*)parentWindow->gobj());\r
-}\r
-\r
-FileDialogBaseWin32::~FileDialogBaseWin32()\r
-{\r
-    g_free(_title);\r
-}\r
-\r
-Inkscape::Extension::Extension *FileDialogBaseWin32::getSelectionType()\r
-{\r
-    return _extension;\r
-}\r
-\r
-Glib::ustring FileDialogBaseWin32::getCurrentDirectory()\r
-{\r
-    return _current_directory;\r
-}\r
-\r
-/*#########################################################################\r
-### F I L E    O P E N\r
-#########################################################################*/\r
-\r
-bool FileOpenDialogImplWin32::_show_preview = true;\r
-\r
-/**\r
- * Constructor.  Not called directly.  Use the factory.\r
- */\r
-FileOpenDialogImplWin32::FileOpenDialogImplWin32(Gtk::Window &parent,  \r
-                                       const Glib::ustring &dir,\r
-                                       FileDialogType fileTypes,\r
-                                       const gchar *title) :\r
-    FileDialogBaseWin32(parent, dir, title, fileTypes, "dialogs.open")\r
-{\r
-    // Initalize to Autodetect\r
-    _extension = NULL;\r
-\r
-    // Set our dialog type (open, import, etc...)\r
-    dialogType = fileTypes;\r
-    \r
-    _show_preview_button_bitmap = NULL;\r
-    _preview_wnd = NULL;\r
-    _file_dialog_wnd = NULL;\r
-    _base_window_proc = NULL;\r
-    \r
-    _preview_file_size = 0;\r
-    _preview_bitmap = NULL;\r
-    _preview_file_icon = NULL;\r
-    _preview_document_width = 0;\r
-    _preview_document_height = 0;\r
-    _preview_image_width = 0;\r
-    _preview_image_height = 0;\r
-    \r
-    createFilterMenu();\r
-}\r
-\r
-\r
-/**\r
- * Destructor\r
- */\r
-FileOpenDialogImplWin32::~FileOpenDialogImplWin32()\r
-{\r
-    if(_filter != NULL)\r
-        delete[] _filter;\r
-    if(_extension_map != NULL)\r
-        delete[] _extension_map;\r
-}\r
-\r
-void FileOpenDialogImplWin32::createFilterMenu()\r
-{\r
-    list<Filter> filter_list;\r
-\r
-    // Compose the filter string\r
-    Inkscape::Extension::DB::InputList extension_list;\r
-    Inkscape::Extension::db.get_input_list(extension_list);\r
-    \r
-    ustring all_inkscape_files_filter, all_image_files_filter;\r
-    Filter all_files, all_inkscape_files, all_image_files;\r
-\r
-    const gchar *all_files_filter_name = _("All Files");\r
-    const gchar *all_inkscape_files_filter_name = ("All Inkscape Files");\r
-    const gchar *all_image_files_filter_name = _("All Image Files");\r
-        \r
-    // Calculate the amount of memory required\r
-    int filter_count = 3;       // 3 - one for All Files, All Images and All Inkscape Files\r
-    int filter_length = 1;\r
-        \r
-    for (Inkscape::Extension::DB::InputList::iterator current_item = extension_list.begin();\r
-         current_item != extension_list.end(); current_item++)\r
-    {\r
-        Filter filter;\r
-    \r
-        Inkscape::Extension::Input *imod = *current_item;\r
-        if (imod->deactivated()) continue;\r
-                \r
-        // Type\r
-        filter.name = g_utf8_to_utf16(imod->get_filetypename(),\r
-            -1, NULL, &filter.name_length, NULL);\r
-        \r
-        // Extension\r
-        const gchar *file_extension_name = imod->get_extension();\r
-        filter.filter = g_utf8_to_utf16(file_extension_name,\r
-            -1, NULL, &filter.filter_length, NULL);\r
-        \r
-        filter.mod = imod;\r
-        filter_list.push_back(filter);\r
-        \r
-        filter_length += filter.name_length +\r
-            filter.filter_length + 3;   // Add 3 for two \0s and a *\r
-            \r
-        // Add to the "All Inkscape Files" Entry\r
-        if(all_inkscape_files_filter.length() > 0)\r
-            all_inkscape_files_filter += ";*";\r
-        all_inkscape_files_filter += file_extension_name;\r
-        if( strncmp("image", imod->get_mimetype(), 5) == 0)\r
-        {\r
-            // Add to the "All Image Files" Entry\r
-            if(all_image_files_filter.length() > 0)\r
-                all_image_files_filter += ";*";\r
-            all_image_files_filter += file_extension_name;\r
-        }\r
-        \r
-        filter_count++;\r
-    }\r
-    \r
-    int extension_index = 0;\r
-    _extension_map = new Inkscape::Extension::Extension*[filter_count];\r
-    \r
-    // Filter Image Files\r
-    all_image_files.name = g_utf8_to_utf16(all_image_files_filter_name,\r
-        -1, NULL, &all_image_files.name_length, NULL);\r
-    all_image_files.filter = g_utf8_to_utf16(all_image_files_filter.data(),\r
-            -1, NULL, &all_image_files.filter_length, NULL);\r
-    filter_list.push_front(all_image_files);\r
-    _extension_map[extension_index++] = NULL;\r
-    \r
-    // Filter Inkscape Files\r
-    all_inkscape_files.name = g_utf8_to_utf16(all_inkscape_files_filter_name,\r
-        -1, NULL, &all_inkscape_files.name_length, NULL);\r
-    all_inkscape_files.filter = g_utf8_to_utf16(all_inkscape_files_filter.data(),\r
-            -1, NULL, &all_inkscape_files.filter_length, NULL);\r
-    filter_list.push_front(all_inkscape_files);\r
-    _extension_map[extension_index++] = NULL;\r
-    \r
-    // Filter All Files\r
-    all_files.name = g_utf8_to_utf16(all_files_filter_name,\r
-        -1, NULL, &all_files.name_length, NULL);\r
-    all_files.filter = NULL;\r
-    all_files.filter_length = 0;\r
-    filter_list.push_front(all_files);\r
-    _extension_map[extension_index++] = NULL;\r
-    \r
-    filter_length += all_files.name_length + 3 +\r
-                    all_inkscape_files.filter_length + \r
-                    all_inkscape_files.name_length + 3 +\r
-                    all_image_files.filter_length +\r
-                    all_image_files.name_length + 3 + 1;\r
-     // Add 3 for 2*2 \0s and a *, and 1 for a trailing \0\r
-      \r
-    \r
-    _filter = new wchar_t[filter_length];\r
-    wchar_t *filterptr = _filter;\r
-    \r
-    for(list<Filter>::iterator filter_iterator = filter_list.begin();\r
-        filter_iterator != filter_list.end(); filter_iterator++)\r
-    {\r
-        const Filter &filter = *filter_iterator;\r
-        \r
-        memcpy(filterptr, filter.name, filter.name_length * 2);\r
-        filterptr += filter.name_length;\r
-        g_free(filter.name);\r
-        \r
-        *(filterptr++) = L'\0';\r
-        *(filterptr++) = L'*';\r
-        \r
-        if(filter.filter != NULL)\r
-        {\r
-            memcpy(filterptr, filter.filter, filter.filter_length * 2);\r
-            filterptr += filter.filter_length;  \r
-            g_free(filter.filter);\r
-        }\r
-    \r
-        *(filterptr++) = L'\0';\r
-        \r
-        // Associate this input extension with the file type name\r
-        _extension_map[extension_index++] = filter.mod;\r
-    }\r
-    *(filterptr++) = L'\0';\r
-    \r
-    _filterIndex = 2;\r
-}\r
-\r
-void FileOpenDialogImplWin32::GetOpenFileName_thread()\r
-{\r
-    OPENFILENAMEEXW ofn;\r
-\r
-    g_assert(this != NULL);\r
-    //g_assert(_mutex != NULL);\r
-    g_assert(_main_loop != NULL);    \r
-        \r
-    WCHAR* current_directory_string = (WCHAR*)g_utf8_to_utf16(\r
-        _current_directory.data(), -1, NULL, NULL, NULL);\r
-        \r
-    memset(&ofn, 0, sizeof(ofn));\r
-    \r
-    // Copy the selected file name, converting from UTF-8 to UTF-16\r
-    memset(_path_string, 0, sizeof(_path_string));\r
-    gunichar2* utf16_path_string = g_utf8_to_utf16(\r
-        myFilename.data(), -1, NULL, NULL, NULL);\r
-    wcsncpy(_path_string, (wchar_t*)utf16_path_string, _MAX_PATH);\r
-    g_free(utf16_path_string);\r
-    \r
-    ofn.lStructSize = sizeof(ofn);\r
-    ofn.hwndOwner = _ownerHwnd;\r
-    ofn.lpstrFile = _path_string;\r
-    ofn.nMaxFile = _MAX_PATH;\r
-    ofn.lpstrFileTitle = NULL;\r
-    ofn.nMaxFileTitle = 0;\r
-    ofn.lpstrInitialDir = current_directory_string;\r
-    ofn.lpstrTitle = _title;\r
-    ofn.Flags = OFN_PATHMUSTEXIST | OFN_FILEMUSTEXIST | OFN_EXPLORER | OFN_ENABLEHOOK | OFN_HIDEREADONLY | OFN_ENABLESIZING;\r
-    ofn.lpstrFilter = _filter;\r
-    ofn.nFilterIndex = _filterIndex;\r
-    ofn.lpfnHook = GetOpenFileName_hookproc;\r
-    ofn.lCustData = (LPARAM)this;\r
-    \r
-    _result = GetOpenFileNameW(&ofn) != 0;\r
-    \r
-    _filterIndex = ofn.nFilterIndex;\r
-    _extension = _extension_map[ofn.nFilterIndex];\r
-\r
-    myFilename = utf16_to_ustring(_path_string, _MAX_PATH);\r
-    \r
-    // Copy the selected file name, converting from UTF-16 to UTF-8\r
-    myFilename = utf16_to_ustring(_path_string, _MAX_PATH);\r
-    \r
-    // Tidy up\r
-    g_free(current_directory_string);\r
-    \r
-    _mutex->lock();\r
-    _finished = true;\r
-    _mutex->unlock();\r
-    //g_main_loop_quit(_main_loop);\r
-    \r
-\r
-}\r
-\r
-void FileOpenDialogImplWin32::register_preview_wnd_class()\r
-{\r
-    HINSTANCE hInstance = GetModuleHandle(NULL);\r
-    const WNDCLASSA PreviewWndClass = \r
-    {\r
-        CS_HREDRAW | CS_VREDRAW,\r
-        preview_wnd_proc,\r
-        0,\r
-        0,\r
-        hInstance,\r
-        NULL,\r
-        LoadCursor(hInstance, IDC_ARROW),\r
-        (HBRUSH)(COLOR_BTNFACE + 1),\r
-        NULL,\r
-        PreviewWindowClassName\r
-    };\r
-\r
-    RegisterClassA(&PreviewWndClass);\r
-}\r
-\r
-UINT_PTR CALLBACK FileOpenDialogImplWin32::GetOpenFileName_hookproc(\r
-    HWND hdlg, UINT uiMsg, WPARAM, LPARAM lParam)\r
-{\r
-    FileOpenDialogImplWin32 *pImpl = (FileOpenDialogImplWin32*)\r
-        GetWindowLongPtr(hdlg, GWLP_USERDATA);\r
-        \r
-    switch(uiMsg)\r
-    {\r
-    case WM_INITDIALOG:\r
-        {\r
-            HWND hParentWnd = GetParent(hdlg);\r
-            HINSTANCE hInstance = GetModuleHandle(NULL);\r
-            \r
-            // Make the window a bit wider\r
-            RECT rcRect;\r
-            GetWindowRect(hParentWnd, &rcRect);\r
-            MoveWindow(hParentWnd, rcRect.left, rcRect.top,\r
-                rcRect.right - rcRect.left + PreviewWidening,\r
-                rcRect.bottom - rcRect.top,\r
-                FALSE);\r
-            \r
-            // Set the pointer to the object\r
-            OPENFILENAMEW *ofn = (OPENFILENAMEW*)lParam;\r
-            SetWindowLongPtr(hdlg, GWLP_USERDATA, ofn->lCustData);\r
-            SetWindowLongPtr(hParentWnd, GWLP_USERDATA, ofn->lCustData);\r
-            pImpl = (FileOpenDialogImplWin32*)ofn->lCustData;\r
-            \r
-            // Subclass the parent\r
-            pImpl->_base_window_proc = (WNDPROC)GetWindowLongPtr(hParentWnd, GWL_WNDPROC);\r
-            SetWindowLongPtr(hParentWnd, GWL_WNDPROC, (LONG_PTR)file_dialog_subclass_proc);\r
-        \r
-            // Add a button to the toolbar\r
-            pImpl->_toolbar_wnd = FindWindowEx(hParentWnd, NULL, "ToolbarWindow32", NULL);\r
-\r
-            pImpl->_show_preview_button_bitmap = LoadBitmap(\r
-                hInstance, MAKEINTRESOURCE(IDC_SHOW_PREVIEW));\r
-            TBADDBITMAP tbAddBitmap = {NULL, (UINT)pImpl->_show_preview_button_bitmap};            \r
-            const int iBitmapIndex = SendMessage(pImpl->_toolbar_wnd,\r
-                TB_ADDBITMAP, 1, (LPARAM)&tbAddBitmap);\r
-    \r
-            TBBUTTON tbButton;\r
-            memset(&tbButton, 0, sizeof(TBBUTTON));\r
-            tbButton.iBitmap = iBitmapIndex;\r
-            tbButton.idCommand = IDC_SHOW_PREVIEW;\r
-            tbButton.fsState = (pImpl->_show_preview ? TBSTATE_CHECKED : 0)\r
-                | TBSTATE_ENABLED;\r
-            tbButton.fsStyle = TBSTYLE_CHECK;\r
-            tbButton.iString = (INT_PTR)_("Show Preview");\r
-            SendMessage(pImpl->_toolbar_wnd, TB_ADDBUTTONS, 1, (LPARAM)&tbButton); \r
-            \r
-            // Create preview pane\r
-            register_preview_wnd_class();\r
-\r
-            pImpl->_mutex->lock();\r
-            \r
-                pImpl->_file_dialog_wnd = hParentWnd;\r
-                \r
-                pImpl->_preview_wnd = \r
-                    CreateWindow(PreviewWindowClassName, "",\r
-                        WS_CHILD | WS_VISIBLE,\r
-                        0, 0, 100, 100, hParentWnd, NULL, hInstance, NULL);\r
-                SetWindowLongPtr(pImpl->_preview_wnd, GWLP_USERDATA, ofn->lCustData);\r
-                    \r
-            pImpl->_mutex->unlock();\r
-                \r
-            pImpl->layout_dialog();\r
-        }\r
-        break;\r
-    \r
-    case WM_NOTIFY:\r
-        {\r
-        \r
-        OFNOTIFY *pOFNotify = reinterpret_cast<OFNOTIFY*>(lParam);\r
-        switch(pOFNotify->hdr.code)\r
-        {\r
-        case CDN_SELCHANGE:\r
-            {\r
-                if(pImpl != NULL)\r
-                {\r
-                    // Get the file name\r
-                    pImpl->_mutex->lock();\r
-                    \r
-                    SendMessage(pOFNotify->hdr.hwndFrom, CDM_GETFILEPATH,\r
-                        sizeof(pImpl->_path_string) / sizeof(wchar_t),\r
-                        (LPARAM)pImpl->_path_string);\r
-                    \r
-                    pImpl->_file_selected = true;\r
-                    \r
-                    pImpl->_mutex->unlock();\r
-                        \r
-                    //pImpl->file_selected();\r
-                }\r
-            }\r
-            break;\r
-        }\r
-        }\r
-        break;\r
-        \r
-    case WM_CLOSE:\r
-        pImpl->_mutex->lock();\r
-        pImpl->_preview_file_size = 0;\r
-    \r
-        pImpl->_file_dialog_wnd = NULL;\r
-        DestroyWindow(pImpl->_preview_wnd);\r
-        pImpl->_preview_wnd = NULL;\r
-        DeleteObject(pImpl->_show_preview_button_bitmap);\r
-        pImpl->_show_preview_button_bitmap = NULL;\r
-        pImpl->_mutex->unlock();\r
-\r
-        break;\r
-    }\r
-        \r
-    // Use default dialog behaviour\r
-    return 0;\r
-}\r
-\r
-LRESULT CALLBACK FileOpenDialogImplWin32::file_dialog_subclass_proc(HWND hwnd, UINT uMsg, WPARAM wParam, LPARAM lParam)\r
-{\r
-    FileOpenDialogImplWin32 *pImpl = (FileOpenDialogImplWin32*)\r
-        GetWindowLongPtr(hwnd, GWLP_USERDATA);\r
-\r
-    LRESULT lResult = CallWindowProc(pImpl->_base_window_proc, hwnd, uMsg, wParam, lParam);\r
-        \r
-    switch(uMsg)\r
-    {\r
-    case WM_SHOWWINDOW:\r
-        if(wParam != 0)\r
-            pImpl->layout_dialog();\r
-        break;\r
-        \r
-    case WM_SIZE:\r
-        pImpl->layout_dialog();\r
-        break;\r
-        \r
-    case WM_COMMAND:\r
-        if(wParam == IDC_SHOW_PREVIEW)\r
-        {\r
-            const bool enable = SendMessage(pImpl->_toolbar_wnd,\r
-                TB_ISBUTTONCHECKED, IDC_SHOW_PREVIEW, 0) != 0;\r
-            pImpl->enable_preview(enable);\r
-        }\r
-        break;\r
-    }\r
-    \r
-    return lResult;\r
-}\r
-\r
-LRESULT CALLBACK FileOpenDialogImplWin32::preview_wnd_proc(HWND hwnd, UINT uMsg, WPARAM wParam, LPARAM lParam)\r
-{\r
-    const int CaptionPadding = 4;\r
-    const int IconSize = 32;\r
-    \r
-    FileOpenDialogImplWin32 *pImpl = (FileOpenDialogImplWin32*)\r
-        GetWindowLongPtr(hwnd, GWLP_USERDATA);\r
-\r
-    LRESULT lResult = 0;\r
-    \r
-    switch(uMsg)\r
-    {\r
-    case WM_ERASEBKGND:\r
-        // Do nothing to erase the background\r
-        //  - otherwise there'll be flicker\r
-        lResult = 1;\r
-        break;\r
-    \r
-    case WM_PAINT:\r
-        {\r
-            // Get the client rect\r
-            RECT rcClient;\r
-            GetClientRect(hwnd, &rcClient);\r
-            \r
-            // Prepare to paint\r
-            PAINTSTRUCT paint_struct;\r
-            HDC dc = BeginPaint(hwnd, &paint_struct);\r
-            \r
-            HFONT hCaptionFont = (HFONT)SendMessage(GetParent(hwnd),\r
-                    WM_GETFONT, 0, 0);\r
-            HFONT hOldFont = (HFONT)SelectObject(dc, hCaptionFont);\r
-            SetBkMode(dc, TRANSPARENT);\r
-            \r
-            pImpl->_mutex->lock();\r
-            \r
-            //FillRect(dc, &client_rect, (HBRUSH)(COLOR_HOTLIGHT+1));\r
-            if(pImpl->_path_string[0] == 0)\r
-            {\r
-                FillRect(dc, &rcClient, (HBRUSH)(COLOR_3DFACE + 1));\r
-                DrawText(dc, _("No file selected"), -1, &rcClient,\r
-                    DT_CENTER | DT_VCENTER | DT_NOPREFIX);\r
-            }\r
-            else if(pImpl->_preview_bitmap != NULL)\r
-            {\r
-                BITMAP bitmap;\r
-                GetObject(pImpl->_preview_bitmap, sizeof(bitmap), &bitmap);\r
-                const int destX = (rcClient.right - bitmap.bmWidth) / 2;\r
-                            \r
-                // Render the image\r
-                HDC hSrcDC = CreateCompatibleDC(dc);\r
-                HBITMAP hOldBitmap = (HBITMAP)SelectObject(hSrcDC, pImpl->_preview_bitmap);\r
-            \r
-                BitBlt(dc, destX, 0, bitmap.bmWidth, bitmap.bmHeight,\r
-                    hSrcDC, 0, 0, SRCCOPY);\r
-                    \r
-                SelectObject(hSrcDC, hOldBitmap);\r
-                DeleteDC(hSrcDC);\r
-                \r
-                // Fill in the background area\r
-                HRGN hEraseRgn = CreateRectRgn(rcClient.left, rcClient.top,\r
-                    rcClient.right, rcClient.bottom);\r
-                HRGN hImageRgn = CreateRectRgn(destX, 0,\r
-                    destX + bitmap.bmWidth, bitmap.bmHeight);\r
-                CombineRgn(hEraseRgn, hEraseRgn, hImageRgn, RGN_DIFF);\r
-                \r
-                FillRgn(dc, hEraseRgn, GetSysColorBrush(COLOR_3DFACE));\r
-                                \r
-                DeleteObject(hImageRgn);\r
-                DeleteObject(hEraseRgn);\r
-                \r
-                // Draw the caption on\r
-                RECT rcCaptionRect = {rcClient.left,\r
-                    rcClient.top + bitmap.bmHeight + CaptionPadding,\r
-                    rcClient.right, rcClient.bottom};\r
-                    \r
-                WCHAR szCaption[_MAX_FNAME + 32];                \r
-                const int iLength = pImpl->format_caption(\r
-                    szCaption, sizeof(szCaption) / sizeof(WCHAR));\r
-        \r
-                DrawTextW(dc, szCaption, iLength, &rcCaptionRect,\r
-                    DT_CENTER | DT_TOP | DT_NOPREFIX | DT_PATH_ELLIPSIS);\r
-            }\r
-            else if(pImpl->_preview_file_icon != NULL)\r
-            {\r
-                FillRect(dc, &rcClient, (HBRUSH)(COLOR_3DFACE + 1));\r
-                \r
-                // Draw the files icon\r
-                const int destX = (rcClient.right - IconSize) / 2;\r
-                DrawIconEx(dc, destX, 0, pImpl->_preview_file_icon,\r
-                    IconSize, IconSize, 0, NULL,\r
-                    DI_NORMAL | DI_COMPAT);\r
-                    \r
-                // Draw the caption on\r
-                RECT rcCaptionRect = {rcClient.left,\r
-                    rcClient.top + IconSize + CaptionPadding,\r
-                    rcClient.right, rcClient.bottom};\r
-                    \r
-                WCHAR szFileName[_MAX_FNAME], szCaption[_MAX_FNAME + 32];\r
-                _wsplitpath(pImpl->_path_string, NULL, NULL, szFileName, NULL);\r
-                \r
-                const int iLength = snwprintf(szCaption,\r
-                    sizeof(szCaption), L"%s\n%d kB",\r
-                    szFileName, pImpl->_preview_file_size);\r
-                \r
-                DrawTextW(dc, szCaption, iLength, &rcCaptionRect,\r
-                    DT_CENTER | DT_TOP | DT_NOPREFIX | DT_PATH_ELLIPSIS);\r
-            }\r
-            else\r
-            {\r
-                // Can't show anything!\r
-                FillRect(dc, &rcClient, (HBRUSH)(COLOR_3DFACE + 1));\r
-            }\r
-            \r
-            pImpl->_mutex->unlock();\r
-            \r
-            // Finish painting\r
-            SelectObject(dc, hOldFont);\r
-            EndPaint(hwnd, &paint_struct);\r
-        }\r
-        \r
-        break;\r
-        \r
-    case WM_DESTROY:\r
-        pImpl->free_preview();\r
-        break;\r
-        \r
-    default:\r
-        lResult = DefWindowProc(hwnd, uMsg, wParam, lParam);\r
-        break;\r
-    }\r
-\r
-    return lResult;\r
-}\r
-\r
-void FileOpenDialogImplWin32::enable_preview(bool enable)\r
-{\r
-    _show_preview = enable;\r
-\r
-    // Relayout the dialog\r
-    ShowWindow(_preview_wnd, enable ? SW_SHOW : SW_HIDE);\r
-    layout_dialog();\r
-    \r
-    // Load or unload the preview\r
-    if(enable)\r
-    {\r
-        _mutex->lock();\r
-        _file_selected = true;\r
-        _mutex->unlock();\r
-    }\r
-    else free_preview();\r
-}\r
-\r
-void FileOpenDialogImplWin32::layout_dialog()\r
-{\r
-    union RECTPOINTS\r
-    {\r
-        RECT r;\r
-        POINT p[2];\r
-    };    \r
-    \r
-    const float MaxExtentScale = 2.0f / 3.0f;\r
-    \r
-    RECT rcClient;\r
-    GetClientRect(_file_dialog_wnd, &rcClient);\r
-\r
-    // Re-layout the dialog\r
-    HWND hFileListWnd = GetDlgItem(_file_dialog_wnd, lst2);\r
-    HWND hFolderComboWnd = GetDlgItem(_file_dialog_wnd, cmb2);\r
-    \r
-    \r
-    RECT rcFolderComboRect;\r
-    RECTPOINTS rcFileList;\r
-    GetWindowRect(hFileListWnd, &rcFileList.r);\r
-    GetWindowRect(hFolderComboWnd, &rcFolderComboRect);\r
-    const int iPadding = rcFileList.r.top - rcFolderComboRect.bottom;\r
-    MapWindowPoints(NULL, _file_dialog_wnd, rcFileList.p, 2);\r
-        \r
-    RECT rcPreview;\r
-    RECT rcBody = {rcFileList.r.left, rcFileList.r.top,\r
-        rcClient.right - iPadding, rcFileList.r.bottom};\r
-    rcFileList.r.right = rcBody.right;\r
-    \r
-    if(_show_preview)\r
-    {\r
-        rcPreview.top = rcBody.top;\r
-        rcPreview.left = rcClient.right - (rcBody.bottom - rcBody.top);\r
-        const int iMaxExtent = (int)(MaxExtentScale * (float)(rcBody.left + rcBody.right)) + iPadding / 2;\r
-        if(rcPreview.left < iMaxExtent) rcPreview.left = iMaxExtent;\r
-        rcPreview.bottom = rcBody.bottom;\r
-        rcPreview.right = rcBody.right;\r
-        \r
-        // Re-layout the preview box\r
-        _mutex->lock();\r
-\r
-            _preview_width = rcPreview.right - rcPreview.left;\r
-            _preview_height = rcPreview.bottom - rcPreview.top;\r
-\r
-        _mutex->unlock();\r
-        \r
-        render_preview();\r
-        \r
-        MoveWindow(_preview_wnd, rcPreview.left, rcPreview.top,\r
-            _preview_width, _preview_height, TRUE);\r
-            \r
-        rcFileList.r.right = rcPreview.left - iPadding;\r
-    }\r
-    \r
-    // Re-layout the file list box\r
-    MoveWindow(hFileListWnd, rcFileList.r.left, rcFileList.r.top,\r
-        rcFileList.r.right - rcFileList.r.left,\r
-        rcFileList.r.bottom - rcFileList.r.top, TRUE);\r
-        \r
-    // Re-layout the toolbar\r
-    RECTPOINTS rcToolBar;\r
-    GetWindowRect(_toolbar_wnd, &rcToolBar.r);\r
-    MapWindowPoints(NULL, _file_dialog_wnd, rcToolBar.p, 2);\r
-    MoveWindow(_toolbar_wnd, rcToolBar.r.left, rcToolBar.r.top, \r
-        rcToolBar.r.right - rcToolBar.r.left, rcToolBar.r.bottom - rcToolBar.r.top, TRUE); \r
-}\r
-\r
-void FileOpenDialogImplWin32::file_selected()\r
-{\r
-    // Destroy any previous previews\r
-    free_preview();\r
-    \r
-\r
-    // Determine if the file exists\r
-    DWORD attributes = GetFileAttributesW(_path_string);\r
-    if(attributes == 0xFFFFFFFF ||\r
-        attributes == FILE_ATTRIBUTE_DIRECTORY)\r
-    {\r
-        InvalidateRect(_preview_wnd, NULL, FALSE);\r
-        return;\r
-    }\r
-\r
-    // Check the file exists and get the file size\r
-    HANDLE file_handle = CreateFileW(_path_string, GENERIC_READ,\r
-        FILE_SHARE_READ, NULL, OPEN_EXISTING, FILE_ATTRIBUTE_NORMAL, NULL);\r
-    if(file_handle == INVALID_HANDLE_VALUE) return;    \r
-    const DWORD file_size = GetFileSize(file_handle, NULL);\r
-    if (file_size == INVALID_FILE_SIZE) return;\r
-    _preview_file_size = file_size / 1024;\r
-    CloseHandle(file_handle);\r
-        \r
-    if(_show_preview) load_preview();    \r
-}\r
-    \r
-void FileOpenDialogImplWin32::load_preview()\r
-{\r
-    // Destroy any previous previews\r
-    free_preview();\r
-    \r
-    // Try to get the file icon\r
-    SHFILEINFOW fileInfo;\r
-    if(SUCCEEDED(SHGetFileInfoW(_path_string, 0, &fileInfo,\r
-        sizeof(fileInfo), SHGFI_ICON | SHGFI_LARGEICON)))\r
-        _preview_file_icon = fileInfo.hIcon;\r
-        \r
-    // Will this file be too big?\r
-    if(_preview_file_size > MaxPreviewFileSize)\r
-    {\r
-        InvalidateRect(_preview_wnd, NULL, FALSE);\r
-        return;\r
-    }\r
-\r
-    // Prepare to render a preview\r
-    const Glib::ustring svg = ".svg";\r
-    const Glib::ustring svgz = ".svgz";\r
-    const Glib::ustring path = utf16_to_ustring(_path_string);\r
-    \r
-    bool success = false;\r
-    \r
-    _preview_document_width = _preview_document_height = 0;\r
-    \r
-    if ((dialogType == SVG_TYPES || dialogType == IMPORT_TYPES) &&\r
-            (hasSuffix(path, svg) || hasSuffix(path, svgz)))\r
-        success = set_svg_preview();\r
-    else if (isValidImageFile(path))\r
-        success = set_image_preview();\r
-    else {\r
-        // Show no preview\r
-    }\r
-    \r
-    if(success) render_preview();\r
-    \r
-    InvalidateRect(_preview_wnd, NULL, FALSE);\r
-}\r
-\r
-void FileOpenDialogImplWin32::free_preview()\r
-{\r
-    _mutex->lock();\r
-    if(_preview_bitmap != NULL)\r
-        DeleteObject(_preview_bitmap);\r
-    _preview_bitmap = NULL;\r
-    \r
-    if(_preview_file_icon != NULL)\r
-        DestroyIcon(_preview_file_icon);\r
-    _preview_file_icon = NULL;\r
-    \r
-    _preview_bitmap_image.clear();\r
-    _mutex->unlock();\r
-}\r
-\r
-bool FileOpenDialogImplWin32::set_svg_preview()\r
-{\r
-    const int PreviewSize = 512;\r
-\r
-    gchar *utf8string = g_utf16_to_utf8((const gunichar2*)_path_string,\r
-        _MAX_PATH, NULL, NULL, NULL);\r
-    SPDocument *svgDoc = sp_document_new (utf8string, true);\r
-    g_free(utf8string);\r
-        \r
-    // Check the document loaded properly        \r
-    if(svgDoc == NULL) return false;\r
-    if(svgDoc->root == NULL)\r
-    {\r
-        sp_document_unref(svgDoc);\r
-        return false;\r
-    }\r
-    \r
-    // Get the size of the document\r
-    const double svgWidth = sp_document_width(svgDoc);\r
-    const double svgHeight = sp_document_height(svgDoc);\r
-    \r
-    // Find the minimum scale to fit the image inside the preview area\r
-    const double scaleFactorX =    PreviewSize / svgWidth;\r
-    const double scaleFactorY =    PreviewSize / svgHeight;\r
-    const double scaleFactor = (scaleFactorX > scaleFactorY) ? scaleFactorY : scaleFactorX;\r
-    \r
-    // Now get the resized values\r
-    const double scaledSvgWidth  = scaleFactor * svgWidth;\r
-    const double scaledSvgHeight = scaleFactor * svgHeight;\r
-    \r
-    NR::Rect area(NR::Point(0, 0), NR::Point(scaledSvgWidth, scaledSvgHeight));\r
-    NRRectL areaL = {0, 0, scaledSvgWidth, scaledSvgHeight};\r
-    NRRectL bbox = {0, 0, scaledSvgWidth, scaledSvgHeight};\r
-        \r
-    // write object bbox to area\r
-    NR::Maybe<NR::Rect> maybeArea(area);\r
-    sp_document_ensure_up_to_date (svgDoc);\r
-    sp_item_invoke_bbox((SPItem *) svgDoc->root, &maybeArea,\r
-        sp_item_i2r_affine((SPItem *)(svgDoc->root)), TRUE);\r
-    \r
-    NRArena *const arena = NRArena::create();\r
-        \r
-    unsigned const key = sp_item_display_key_new(1);\r
-    \r
-    NRArenaItem *root = sp_item_invoke_show((SPItem*)(svgDoc->root),\r
-        arena, key, SP_ITEM_SHOW_DISPLAY);\r
-    \r
-    NRGC gc(NULL);\r
-    nr_matrix_set_scale(&gc.transform, scaleFactor, scaleFactor);\r
-    \r
-    nr_arena_item_invoke_update (root, NULL, &gc,\r
-        NR_ARENA_ITEM_STATE_ALL, NR_ARENA_ITEM_STATE_NONE);\r
-    \r
-    // Prepare a GDI compatible NRPixBlock\r
-    NRPixBlock pixBlock;\r
-    pixBlock.size = NR_PIXBLOCK_SIZE_BIG;\r
-    pixBlock.mode = NR_PIXBLOCK_MODE_R8G8B8;\r
-    pixBlock.empty = 1;\r
-    pixBlock.visible_area.x0 = pixBlock.area.x0 = 0;\r
-    pixBlock.visible_area.y0 = pixBlock.area.y0 = 0;\r
-    pixBlock.visible_area.x1 = pixBlock.area.x1 = scaledSvgWidth;\r
-    pixBlock.visible_area.y1 = pixBlock.area.y1 = scaledSvgHeight;\r
-    pixBlock.rs = 4 * ((3 * (int)scaledSvgWidth + 3) / 4);\r
-    pixBlock.data.px = g_try_new (unsigned char, pixBlock.rs * scaledSvgHeight);\r
-    \r
-    // Fail if the pixblock failed to allocate\r
-    if(pixBlock.data.px == NULL)\r
-    {\r
-        sp_document_unref(svgDoc);\r
-        return false;\r
-    }\r
-    \r
-    memset(pixBlock.data.px, 0xFF, pixBlock.rs * scaledSvgHeight);\r
-    \r
-    memcpy(&root->bbox, &areaL, sizeof(areaL));\r
-            \r
-    // Render the image\r
-    nr_arena_item_invoke_render(NULL, root, &bbox, &pixBlock, /*0*/NR_ARENA_ITEM_RENDER_NO_CACHE);\r
-    \r
-    // Tidy up\r
-    sp_document_unref(svgDoc);\r
-    sp_item_invoke_hide((SPItem*)(svgDoc->root), key);\r
-    nr_arena_item_unref(root);\r
-    nr_object_unref((NRObject *) arena);\r
-    \r
-    // Create the GDK pixbuf\r
-    _mutex->lock();\r
-    \r
-    _preview_bitmap_image = Gdk::Pixbuf::create_from_data(\r
-        pixBlock.data.px, Gdk::COLORSPACE_RGB, false, 8,\r
-        (int)scaledSvgWidth, (int)scaledSvgHeight, pixBlock.rs,\r
-        sigc::ptr_fun(destroy_svg_rendering));\r
-\r
-    _preview_document_width = scaledSvgWidth;\r
-    _preview_document_height = scaledSvgHeight;\r
-    _preview_image_width = svgWidth;\r
-    _preview_image_height = svgHeight;\r
-        \r
-    _mutex->unlock();\r
-        \r
-    return true;\r
-}\r
-\r
-void FileOpenDialogImplWin32::destroy_svg_rendering(const guint8 *buffer)\r
-{\r
-    g_assert(buffer != NULL);\r
-    g_free((void*)buffer);\r
-}\r
-    \r
-bool FileOpenDialogImplWin32::set_image_preview()\r
-{\r
-    const Glib::ustring path = utf16_to_ustring(_path_string, _MAX_PATH);\r
-    \r
-    _mutex->lock();\r
-    _preview_bitmap_image = Gdk::Pixbuf::create_from_file(path);\r
-    if(!_preview_bitmap_image) return false;\r
-    \r
-    _preview_image_width = _preview_bitmap_image->get_width();\r
-    _preview_document_width = _preview_image_width;\r
-    _preview_image_height = _preview_bitmap_image->get_height();\r
-    _preview_document_height = _preview_image_height;\r
-    \r
-    _mutex->unlock();\r
-\r
-    return true;\r
-}\r
-\r
-void FileOpenDialogImplWin32::render_preview()\r
-{\r
-    double x, y;\r
-    const double blurRadius = 8;\r
-    const double halfBlurRadius = blurRadius / 2;\r
-    const int shaddowOffsetX = 0;\r
-    const int shaddowOffsetY = 2;\r
-    const int pagePadding = 5;\r
-    const double shaddowAlpha = 0.75;\r
-    \r
-    // Is the preview showing?\r
-    if(!_show_preview)\r
-        return;\r
-    \r
-    // Do we have anything to render?\r
-    _mutex->lock();\r
-    \r
-    if(!_preview_bitmap_image)\r
-    {\r
-        _mutex->unlock();\r
-        return;\r
-    }\r
-        \r
-    // Tidy up any previous bitmap renderings\r
-    if(_preview_bitmap != NULL)\r
-        DeleteObject(_preview_bitmap);\r
-    _preview_bitmap = NULL;\r
-    \r
-    // Calculate the size of the caption\r
-    int captionHeight = 0;\r
-\r
-    if(_preview_wnd != NULL)\r
-    {\r
-        RECT rcCaptionRect;\r
-        WCHAR szCaption[_MAX_FNAME + 32];                \r
-        const int iLength = format_caption(szCaption,\r
-            sizeof(szCaption) / sizeof(WCHAR));\r
-    \r
-        HDC dc = GetDC(_preview_wnd);\r
-        DrawTextW(dc, szCaption, iLength, &rcCaptionRect,\r
-            DT_CENTER | DT_TOP | DT_NOPREFIX | DT_PATH_ELLIPSIS | DT_CALCRECT);\r
-        ReleaseDC(_preview_wnd, dc);\r
-    \r
-        captionHeight = rcCaptionRect.bottom - rcCaptionRect.top;\r
-    }\r
-    \r
-    // Find the minimum scale to fit the image inside the preview area\r
-    const double scaleFactorX =\r
-        ((double)_preview_width - pagePadding * 2 - blurRadius)  / _preview_document_width;\r
-    const double scaleFactorY =\r
-        ((double)_preview_height - pagePadding * 2\r
-        - shaddowOffsetY - halfBlurRadius - captionHeight) / _preview_document_height;\r
-    double scaleFactor = (scaleFactorX > scaleFactorY) ? scaleFactorY : scaleFactorX;\r
-    scaleFactor = (scaleFactor > 1.0) ? 1.0 : scaleFactor;    \r
-    \r
-    // Now get the resized values\r
-    const double scaledSvgWidth  = scaleFactor * _preview_document_width;\r
-    const double scaledSvgHeight = scaleFactor * _preview_document_height;\r
-    \r
-    const int svgX = pagePadding + halfBlurRadius;\r
-    const int svgY = pagePadding;\r
-    \r
-    const int frameX = svgX - pagePadding;\r
-    const int frameY = svgY - pagePadding;\r
-    const int frameWidth = scaledSvgWidth + pagePadding * 2;\r
-    const int frameHeight = scaledSvgHeight + pagePadding * 2;\r
-    \r
-    const int totalWidth = (int)ceil(frameWidth + blurRadius);\r
-    const int totalHeight = (int)ceil(frameHeight + blurRadius);\r
-    \r
-    // Prepare the drawing surface\r
-    HDC hDC = GetDC(_preview_wnd);\r
-    HDC hMemDC = CreateCompatibleDC(hDC);\r
-    _preview_bitmap = CreateCompatibleBitmap(hDC, totalWidth, totalHeight);\r
-    HBITMAP hOldBitmap = (HBITMAP)SelectObject(hMemDC, _preview_bitmap);\r
-    Cairo::RefPtr<Win32Surface> surface = Win32Surface::create(hMemDC);\r
-    Cairo::RefPtr<Context> context = Context::create(surface);\r
-\r
-    // Paint the background to match the dialog colour\r
-    const COLORREF background = GetSysColor(COLOR_3DFACE);  \r
-    context->set_source_rgb(\r
-        GetRValue(background) / 255.0,\r
-        GetGValue(background) / 255.0,\r
-        GetBValue(background) / 255.0);\r
-    context->paint();\r
-     \r
-    //----- Draw the drop shaddow -----//\r
-    \r
-    // Left Edge\r
-    x = frameX + shaddowOffsetX - halfBlurRadius;\r
-    Cairo::RefPtr<LinearGradient> leftEdgeFade = LinearGradient::create(\r
-        x, 0.0, x + blurRadius, 0.0);\r
-    leftEdgeFade->add_color_stop_rgba (0, 0, 0, 0, 0);\r
-    leftEdgeFade->add_color_stop_rgba (1, 0, 0, 0, shaddowAlpha);\r
-    context->set_source(leftEdgeFade);\r
-    context->rectangle (x, frameY + shaddowOffsetY + halfBlurRadius,\r
-        blurRadius, frameHeight - blurRadius);\r
-    context->fill();\r
-    \r
-    // Right Edge\r
-    x = frameX + frameWidth + shaddowOffsetX - halfBlurRadius;\r
-    Cairo::RefPtr<LinearGradient> rightEdgeFade = LinearGradient::create(\r
-        x, 0.0,    x + blurRadius, 0.0);\r
-    rightEdgeFade->add_color_stop_rgba (0, 0, 0, 0, shaddowAlpha);\r
-    rightEdgeFade->add_color_stop_rgba (1, 0, 0, 0, 0);\r
-    context->set_source(rightEdgeFade);\r
-    context->rectangle (frameX + frameWidth + shaddowOffsetX - halfBlurRadius,\r
-        frameY + shaddowOffsetY + halfBlurRadius,\r
-        blurRadius, frameHeight - blurRadius);\r
-    context->fill();\r
-        \r
-    // Top Edge\r
-    y = frameY + shaddowOffsetY - halfBlurRadius;\r
-    Cairo::RefPtr<LinearGradient> topEdgeFade = LinearGradient::create(\r
-        0.0, y, 0.0, y + blurRadius);\r
-    topEdgeFade->add_color_stop_rgba (0, 0, 0, 0, 0);\r
-    topEdgeFade->add_color_stop_rgba (1, 0, 0, 0, shaddowAlpha);\r
-    context->set_source(topEdgeFade);\r
-    context->rectangle (frameX + shaddowOffsetX + halfBlurRadius, y,\r
-        frameWidth - blurRadius, blurRadius);\r
-    context->fill();\r
-    \r
-    // Bottom Edge\r
-    y = frameY + frameHeight + shaddowOffsetY - halfBlurRadius;\r
-    Cairo::RefPtr<LinearGradient> bottomEdgeFade = LinearGradient::create(\r
-        0.0, y,    0.0, y + blurRadius);\r
-    bottomEdgeFade->add_color_stop_rgba (0, 0, 0, 0, shaddowAlpha);\r
-    bottomEdgeFade->add_color_stop_rgba (1, 0, 0, 0, 0);\r
-    context->set_source(bottomEdgeFade);\r
-    context->rectangle (frameX + shaddowOffsetX + halfBlurRadius, y,\r
-        frameWidth - blurRadius, blurRadius);\r
-    context->fill();\r
-    \r
-    // Top Left Corner\r
-    x = frameX + shaddowOffsetX - halfBlurRadius;\r
-    y = frameY + shaddowOffsetY - halfBlurRadius;\r
-    Cairo::RefPtr<RadialGradient> topLeftCornerFade = RadialGradient::create(\r
-        x + blurRadius, y + blurRadius, 0, x + blurRadius, y + blurRadius, blurRadius);\r
-    topLeftCornerFade->add_color_stop_rgba (0, 0, 0, 0, shaddowAlpha);\r
-    topLeftCornerFade->add_color_stop_rgba (1, 0, 0, 0, 0);\r
-    context->set_source(topLeftCornerFade);\r
-    context->rectangle (x, y, blurRadius, blurRadius);\r
-    context->fill();\r
-    \r
-    // Top Right Corner\r
-    x = frameX + frameWidth + shaddowOffsetX - halfBlurRadius;\r
-    y = frameY + shaddowOffsetY - halfBlurRadius;\r
-    Cairo::RefPtr<RadialGradient> topRightCornerFade = RadialGradient::create(\r
-        x, y + blurRadius, 0, x, y + blurRadius, blurRadius);\r
-    topRightCornerFade->add_color_stop_rgba (0, 0, 0, 0, shaddowAlpha);\r
-    topRightCornerFade->add_color_stop_rgba (1, 0, 0, 0, 0);\r
-    context->set_source(topRightCornerFade);\r
-    context->rectangle (x, y, blurRadius, blurRadius);\r
-    context->fill();\r
-    \r
-    // Bottom Left Corner\r
-    x = frameX + shaddowOffsetX - halfBlurRadius;\r
-    y = frameY + frameHeight + shaddowOffsetY - halfBlurRadius;\r
-    Cairo::RefPtr<RadialGradient> bottomLeftCornerFade = RadialGradient::create(\r
-        x + blurRadius, y, 0, x + blurRadius, y, blurRadius);\r
-    bottomLeftCornerFade->add_color_stop_rgba (0, 0, 0, 0, shaddowAlpha);\r
-    bottomLeftCornerFade->add_color_stop_rgba (1, 0, 0, 0, 0);\r
-    context->set_source(bottomLeftCornerFade);\r
-    context->rectangle (x, y, blurRadius, blurRadius);\r
-    context->fill();\r
-    \r
-    // Bottom Right Corner\r
-    x = frameX + frameWidth + shaddowOffsetX - halfBlurRadius;\r
-    y = frameY + frameHeight + shaddowOffsetY - halfBlurRadius;\r
-    Cairo::RefPtr<RadialGradient> bottomRightCornerFade = RadialGradient::create(\r
-        x, y, 0, x, y, blurRadius);\r
-    bottomRightCornerFade->add_color_stop_rgba (0, 0, 0, 0, shaddowAlpha);\r
-    bottomRightCornerFade->add_color_stop_rgba (1, 0, 0, 0, 0);\r
-    context->set_source(bottomRightCornerFade);\r
-    context->rectangle (frameX + frameWidth + shaddowOffsetX - halfBlurRadius,\r
-        frameY + frameHeight + shaddowOffsetY - halfBlurRadius,\r
-        blurRadius, blurRadius);\r
-    context->fill();\r
-    \r
-    // Draw the frame\r
-    context->set_line_width(1);\r
-    context->rectangle (frameX, frameY,    frameWidth, frameHeight);\r
-    \r
-    context->set_source_rgb(1.0, 1.0, 1.0);\r
-    context->fill_preserve();\r
-    context->set_source_rgb(0.25, 0.25, 0.25);\r
-    context->stroke_preserve();\r
-    \r
-    // Draw the image\r
-    \r
-    if(_preview_bitmap_image)    // Is the image a pixbuf?\r
-    {\r
-        // Set the transformation\r
-        const Matrix matrix = {\r
-            scaleFactor, 0,\r
-            0, scaleFactor,\r
-            svgX, svgY };\r
-        context->set_matrix (matrix);\r
-    \r
-        // Render the image\r
-        set_source_pixbuf (context, _preview_bitmap_image, 0, 0);\r
-        context->paint();\r
-        \r
-        // Reset the transformation\r
-        context->set_identity_matrix();\r
-    }\r
-    \r
-    // Draw the inner frame\r
-    context->set_source_rgb(0.75, 0.75, 0.75);\r
-    context->rectangle (svgX, svgY,    scaledSvgWidth, scaledSvgHeight);\r
-    context->stroke();\r
-    \r
-    _mutex->unlock();\r
-\r
-    // Finish drawing\r
-    surface->finish();\r
-    SelectObject(hMemDC, hOldBitmap) ;\r
-    DeleteDC(hMemDC);\r
-    \r
-    // Refresh the preview pane\r
-    InvalidateRect(_preview_wnd, NULL, FALSE);\r
-}\r
-\r
-int FileOpenDialogImplWin32::format_caption(wchar_t *caption, int caption_size)\r
-{\r
-    wchar_t szFileName[_MAX_FNAME];\r
-    _wsplitpath(_path_string, NULL, NULL, szFileName, NULL);\r
-                \r
-    return snwprintf(caption, caption_size,\r
-        L"%s\n%d kB\n%d \xD7 %d", szFileName, _preview_file_size,\r
-        (int)_preview_document_width, (int)_preview_document_height);\r
-}\r
-\r
-/**\r
- * Show this dialog modally.  Return true if user hits [OK]\r
- */\r
-bool\r
-FileOpenDialogImplWin32::show()\r
-{\r
-    // We can only run one worker thread at a time\r
-    //if(_mutex != NULL) return false;\r
-    \r
-    if(!Glib::thread_supported())\r
-        Glib::thread_init();\r
-    \r
-    _result = false;\r
-    _finished = false;\r
-    _file_selected = false;\r
-    _mutex = new Glib::Mutex();\r
-    _main_loop = g_main_loop_new(g_main_context_default(), FALSE);\r
-    \r
-    if(Glib::Thread::create(sigc::mem_fun(*this, &FileOpenDialogImplWin32::GetOpenFileName_thread), true))\r
-    {\r
-        while(1)\r
-        {\r
-            g_main_context_iteration(g_main_context_default(), FALSE);\r
-            \r
-            if(_mutex->trylock())\r
-            {\r
-                // Read mutexed data\r
-                const bool finished = _finished;\r
-                const bool is_file_selected = _file_selected;\r
-                _file_selected = false;\r
-                _mutex->unlock();\r
-                \r
-                if(finished) break;\r
-                if(is_file_selected) file_selected();\r
-            }\r
-            \r
-            Sleep(10);\r
-        }\r
-        //g_main_loop_run(_main_loop);\r
-    }\r
-    \r
-    // Tidy up    \r
-    delete _mutex;\r
-    _mutex = NULL;\r
-        \r
-    return _result;\r
-}\r
-\r
-/**\r
- * To Get Multiple filenames selected at-once.\r
- */\r
-std::vector<Glib::ustring>FileOpenDialogImplWin32::getFilenames()\r
-{\r
-    std::vector<Glib::ustring> result;\r
-    result.push_back(getFilename());\r
-    return result;\r
-}\r
-\r
-\r
-/*#########################################################################\r
-### F I L E    S A V E\r
-#########################################################################*/\r
-\r
-/**\r
- * Constructor\r
- */\r
-FileSaveDialogImplWin32::FileSaveDialogImplWin32(Gtk::Window &parent, \r
-            const Glib::ustring &dir,\r
-            FileDialogType fileTypes,\r
-            const char *title,\r
-            const Glib::ustring &/*default_key*/) :\r
-    FileDialogBaseWin32(parent, dir, title, fileTypes, "dialogs.save_as")\r
-{\r
-    _main_loop = NULL;\r
-\r
-    createFilterMenu();\r
-}\r
-\r
-FileSaveDialogImplWin32::~FileSaveDialogImplWin32()\r
-{\r
-}\r
-\r
-void FileSaveDialogImplWin32::createFilterMenu()\r
-{\r
-    list<Filter> filter_list;\r
-\r
-    knownExtensions.clear();\r
-\r
-    // Compose the filter string\r
-    Glib::ustring all_inkscape_files_filter, all_image_files_filter;\r
-    Inkscape::Extension::DB::OutputList extension_list;\r
-    Inkscape::Extension::db.get_output_list(extension_list);\r
-\r
-    int filter_count = 0;\r
-    int filter_length = 0;\r
-            \r
-    for (Inkscape::Extension::DB::OutputList::iterator current_item = extension_list.begin();\r
-         current_item != extension_list.end(); current_item++)\r
-    {\r
-        Inkscape::Extension::Output *omod = *current_item;\r
-        if (omod->deactivated()) continue;\r
-        \r
-        filter_count++;\r
-        \r
-        Filter filter;\r
-        \r
-        // Extension\r
-        const gchar *filter_extension = omod->get_extension();      \r
-        filter.filter = g_utf8_to_utf16(\r
-            filter_extension, -1, NULL, &filter.filter_length, NULL);    \r
-        knownExtensions.insert( Glib::ustring(filter_extension).casefold() );\r
-        \r
-        // Type\r
-        filter.name = g_utf8_to_utf16(\r
-            omod->get_filetypename(), -1, NULL, &filter.name_length, NULL);\r
-            \r
-        filter.mod = omod;\r
-                        \r
-        filter_length += filter.name_length +\r
-            filter.filter_length + 3;   // Add 3 for two \0s and a *\r
-            \r
-        filter_list.push_back(filter);\r
-    }\r
-     \r
-    int extension_index = 0;\r
-    _extension_map = new Inkscape::Extension::Extension*[filter_count];\r
-    \r
-    _filter = new wchar_t[filter_length];\r
-    wchar_t *filterptr = _filter;\r
-    \r
-    for(list<Filter>::iterator filter_iterator = filter_list.begin();\r
-        filter_iterator != filter_list.end(); filter_iterator++)\r
-    {\r
-        const Filter &filter = *filter_iterator;\r
-    \r
-        memcpy(filterptr, filter.name, filter.name_length * 2);\r
-        filterptr += filter.name_length;\r
-        g_free(filter.name);\r
-    \r
-        *(filterptr++) = L'\0';\r
-        *(filterptr++) = L'*';\r
-\r
-        memcpy(filterptr, filter.filter, filter.filter_length * 2);\r
-        filterptr += filter.filter_length;\r
-        g_free(filter.filter);\r
-    \r
-        *(filterptr++) = L'\0';\r
-        \r
-        // Associate this input extension with the file type name\r
-        _extension_map[extension_index++] = filter.mod;\r
-    }\r
-    *(filterptr++) = 0;\r
-    \r
-    _filterIndex = 0;\r
-}\r
-\r
-void FileSaveDialogImplWin32::GetSaveFileName_thread()\r
-{\r
-    OPENFILENAMEEXW ofn;\r
-    \r
-    g_assert(this != NULL);\r
-    //g_assert(_mutex != NULL);\r
-    g_assert(_main_loop != NULL);    \r
-\r
-    gunichar2* current_directory_string = g_utf8_to_utf16(\r
-        _current_directory.data(), -1, NULL, NULL, NULL);\r
-    \r
-    // Copy the selected file name, converting from UTF-8 to UTF-16\r
-    memset(_path_string, 0, sizeof(_path_string));\r
-    gunichar2* utf16_path_string = g_utf8_to_utf16(\r
-        myFilename.data(), -1, NULL, NULL, NULL);\r
-    wcsncpy(_path_string, (wchar_t*)utf16_path_string, _MAX_PATH);\r
-    g_free(utf16_path_string);\r
-    \r
-    ZeroMemory(&ofn, sizeof(ofn));\r
-    ofn.lStructSize = sizeof(ofn);\r
-    ofn.hwndOwner = _ownerHwnd;\r
-    ofn.lpstrFile = _path_string;\r
-    ofn.nMaxFile = _MAX_PATH;\r
-    ofn.nFilterIndex = _filterIndex;\r
-    ofn.lpstrFileTitle = NULL;\r
-    ofn.nMaxFileTitle = 0;\r
-    ofn.lpstrInitialDir = (wchar_t*)current_directory_string;\r
-    ofn.lpstrTitle = _title;\r
-    ofn.Flags = OFN_PATHMUSTEXIST | OFN_FILEMUSTEXIST;\r
-    ofn.lpstrFilter = _filter;\r
-    ofn.nFilterIndex = _filterIndex;\r
-    \r
-    _result = GetSaveFileNameW(&ofn) != 0;\r
-    \r
-    _filterIndex = ofn.nFilterIndex;\r
-    _extension = _extension_map[ofn.nFilterIndex];\r
-    \r
-    // Copy the selected file name, converting from UTF-16 to UTF-8\r
-    myFilename = utf16_to_ustring(_path_string, _MAX_PATH);\r
-        \r
-    //_mutex->lock();\r
-    //_finished = true;\r
-    //_mutex->unlock();\r
-    \r
-    \r
-    // Tidy up\r
-    g_free(current_directory_string);\r
-    \r
-    g_main_loop_quit(_main_loop);\r
-}\r
-\r
-/**\r
- * Show this dialog modally.  Return true if user hits [OK]\r
- */\r
-bool\r
-FileSaveDialogImplWin32::show()\r
-{\r
-    // We can only run one worker thread at a time\r
-    //if(_mutex != NULL) return false;\r
-\r
-    if(!Glib::thread_supported())\r
-        Glib::thread_init();\r
-        \r
-    _result = false;\r
-    //_finished = false;\r
-    //_mutex = new Glib::Mutex();\r
-    _main_loop = g_main_loop_new(g_main_context_default(), FALSE);\r
-    \r
-    if(Glib::Thread::create(sigc::mem_fun(*this, &FileSaveDialogImplWin32::GetSaveFileName_thread), true))\r
-    {\r
-        /*while(1)\r
-        {\r
-            // While the dialog runs - keep the main UI alive\r
-            g_main_context_iteration(g_main_context_default(), FALSE);\r
-            \r
-            if(_mutex->trylock())\r
-            {\r
-                if(_finished) break;\r
-                _mutex->unlock();\r
-            }\r
-            \r
-            Sleep(10);\r
-        }*/\r
-        g_main_loop_run(_main_loop);\r
-    }\r
-    //delete _mutex;\r
-    //_mutex = NULL;\r
-        \r
-    if(_result)\r
-        appendExtension(myFilename, (Inkscape::Extension::Output*)_extension);\r
-        \r
-    return _result;   \r
-}\r
-\r
-void FileSaveDialogImplWin32::setSelectionType( Inkscape::Extension::Extension * /*key*/ )\r
-{\r
-    // If no pointer to extension is passed in, look up based on filename extension.\r
-    \r
-}\r
-\r
-}\r
-}\r
-}\r
-\r
-#endif\r
-\r
-/*\r
-  Local Variables:\r
-  mode:c++\r
-  c-file-style:"stroustrup"\r
-  c-file-offsets:((innamespace . 0)(inline-open . 0)(case-label . +))\r
-  indent-tabs-mode:nil\r
-  fill-column:99\r
-  End:\r
-*/\r
-// vim: filetype=cpp:expandtab:shiftwidth=4:tabstop=8:softtabstop=4 :\r
+/**
+ * Implementation of the file dialog interfaces defined in filedialog.h for Win32
+ *
+ * Authors:
+ *   Joel Holdsworth
+ *   The Inkscape Organization
+ *
+ * Copyright (C) 2004-2008 The Inkscape Organization
+ *
+ * Released under GNU GPL, read the file 'COPYING' for more information
+ */
+
+#ifdef HAVE_CONFIG_H
+# include <config.h>
+#endif
+
+#ifdef WIN32
+
+//General includes
+#include <list>
+#include <unistd.h>
+#include <sys/stat.h>
+#include <errno.h>
+#include <set>
+#include <gdk/gdkwin32.h>
+#include <glib/gstdio.h>
+#include <glibmm/i18n.h>
+#include <gtkmm/window.h>
+
+//Inkscape includes
+#include "inkscape.h"
+#include "prefs-utils.h"
+#include <dialogs/dialog-events.h>
+#include <extension/input.h>
+#include <extension/output.h>
+#include <extension/db.h>
+
+#include <libnr/nr-pixops.h>
+#include <libnr/nr-translate-scale-ops.h>
+#include <display/nr-arena-item.h>
+#include <display/nr-arena.h>
+#include "sp-item.h"
+#include "canvas-arena.h"
+
+#include "filedialog.h"
+#include "filedialogimpl-win32.h"
+
+#include <zlib.h>
+#include <cairomm/win32_surface.h>
+#include <cairomm/context.h>
+
+using namespace std;
+using namespace Glib;
+using namespace Cairo;
+using namespace Gdk::Cairo;
+
+namespace Inkscape
+{
+namespace UI
+{
+namespace Dialog
+{
+
+const int PreviewWidening = 150;
+const char PreviewWindowClassName[] = "PreviewWnd";
+const unsigned long MaxPreviewFileSize = 1344; // kB
+
+#define IDC_SHOW_PREVIEW    1000
+
+// Windows 2000 version of OPENFILENAMEW
+struct OPENFILENAMEEXW : public OPENFILENAMEW {
+  void *        pvReserved;
+  DWORD         dwReserved;
+  DWORD         FlagsEx;
+};
+
+struct Filter
+{
+    gunichar2* name;
+    glong name_length;
+    gunichar2* filter;
+    glong filter_length;
+    Inkscape::Extension::Extension* mod;
+};
+
+ustring utf16_to_ustring(const wchar_t *utf16string, int utf16length = -1)
+{
+    gchar *utf8string = g_utf16_to_utf8((const gunichar2*)utf16string,
+        utf16length, NULL, NULL, NULL);
+    ustring result(utf8string);
+    g_free(utf8string);
+
+    return result;
+}
+
+/*#########################################################################
+### F I L E     D I A L O G    B A S E    C L A S S
+#########################################################################*/
+
+FileDialogBaseWin32::FileDialogBaseWin32(Gtk::Window &parent,
+        const Glib::ustring &dir, const gchar *title,
+        FileDialogType type, gchar const* /*preferenceBase*/) :
+        dialogType(type),
+        parent(parent),
+        _current_directory(dir)
+{
+    //_mutex = NULL;
+    _main_loop = NULL;
+
+    _title = (wchar_t*)g_utf8_to_utf16(title, -1, NULL, NULL, NULL);
+
+    Glib::RefPtr<const Gdk::Window> parentWindow = parent.get_window();
+    g_assert(parentWindow->gobj() != NULL);
+    _ownerHwnd = (HWND)gdk_win32_drawable_get_handle((GdkDrawable*)parentWindow->gobj());
+}
+
+FileDialogBaseWin32::~FileDialogBaseWin32()
+{
+    g_free(_title);
+}
+
+Inkscape::Extension::Extension *FileDialogBaseWin32::getSelectionType()
+{
+    return _extension;
+}
+
+Glib::ustring FileDialogBaseWin32::getCurrentDirectory()
+{
+    return _current_directory;
+}
+
+/*#########################################################################
+### F I L E    O P E N
+#########################################################################*/
+
+bool FileOpenDialogImplWin32::_show_preview = true;
+
+/**
+ * Constructor.  Not called directly.  Use the factory.
+ */
+FileOpenDialogImplWin32::FileOpenDialogImplWin32(Gtk::Window &parent,
+                                       const Glib::ustring &dir,
+                                       FileDialogType fileTypes,
+                                       const gchar *title) :
+    FileDialogBaseWin32(parent, dir, title, fileTypes, "dialogs.open")
+{
+    // Initalize to Autodetect
+    _extension = NULL;
+
+    // Set our dialog type (open, import, etc...)
+    dialogType = fileTypes;
+
+    _show_preview_button_bitmap = NULL;
+    _preview_wnd = NULL;
+    _file_dialog_wnd = NULL;
+    _base_window_proc = NULL;
+
+    _preview_file_size = 0;
+    _preview_bitmap = NULL;
+    _preview_file_icon = NULL;
+    _preview_document_width = 0;
+    _preview_document_height = 0;
+    _preview_image_width = 0;
+    _preview_image_height = 0;
+
+    createFilterMenu();
+}
+
+
+/**
+ * Destructor
+ */
+FileOpenDialogImplWin32::~FileOpenDialogImplWin32()
+{
+    if(_filter != NULL)
+        delete[] _filter;
+    if(_extension_map != NULL)
+        delete[] _extension_map;
+}
+
+void FileOpenDialogImplWin32::createFilterMenu()
+{
+    list<Filter> filter_list;
+
+    // Compose the filter string
+    Inkscape::Extension::DB::InputList extension_list;
+    Inkscape::Extension::db.get_input_list(extension_list);
+
+    ustring all_inkscape_files_filter, all_image_files_filter;
+    Filter all_files, all_inkscape_files, all_image_files;
+
+    const gchar *all_files_filter_name = _("All Files");
+    const gchar *all_inkscape_files_filter_name = ("All Inkscape Files");
+    const gchar *all_image_files_filter_name = _("All Image Files");
+
+    // Calculate the amount of memory required
+    int filter_count = 3;       // 3 - one for All Files, All Images and All Inkscape Files
+    int filter_length = 1;
+
+    for (Inkscape::Extension::DB::InputList::iterator current_item = extension_list.begin();
+         current_item != extension_list.end(); current_item++)
+    {
+        Filter filter;
+
+        Inkscape::Extension::Input *imod = *current_item;
+        if (imod->deactivated()) continue;
+
+        // Type
+        filter.name = g_utf8_to_utf16(imod->get_filetypename(),
+            -1, NULL, &filter.name_length, NULL);
+
+        // Extension
+        const gchar *file_extension_name = imod->get_extension();
+        filter.filter = g_utf8_to_utf16(file_extension_name,
+            -1, NULL, &filter.filter_length, NULL);
+
+        filter.mod = imod;
+        filter_list.push_back(filter);
+
+        filter_length += filter.name_length +
+            filter.filter_length + 3;   // Add 3 for two \0s and a *
+
+        // Add to the "All Inkscape Files" Entry
+        if(all_inkscape_files_filter.length() > 0)
+            all_inkscape_files_filter += ";*";
+        all_inkscape_files_filter += file_extension_name;
+        if( strncmp("image", imod->get_mimetype(), 5) == 0)
+        {
+            // Add to the "All Image Files" Entry
+            if(all_image_files_filter.length() > 0)
+                all_image_files_filter += ";*";
+            all_image_files_filter += file_extension_name;
+        }
+
+        filter_count++;
+    }
+
+    int extension_index = 0;
+    _extension_map = new Inkscape::Extension::Extension*[filter_count];
+
+    // Filter Image Files
+    all_image_files.name = g_utf8_to_utf16(all_image_files_filter_name,
+        -1, NULL, &all_image_files.name_length, NULL);
+    all_image_files.filter = g_utf8_to_utf16(all_image_files_filter.data(),
+            -1, NULL, &all_image_files.filter_length, NULL);
+    filter_list.push_front(all_image_files);
+    _extension_map[extension_index++] = NULL;
+
+    // Filter Inkscape Files
+    all_inkscape_files.name = g_utf8_to_utf16(all_inkscape_files_filter_name,
+        -1, NULL, &all_inkscape_files.name_length, NULL);
+    all_inkscape_files.filter = g_utf8_to_utf16(all_inkscape_files_filter.data(),
+            -1, NULL, &all_inkscape_files.filter_length, NULL);
+    filter_list.push_front(all_inkscape_files);
+    _extension_map[extension_index++] = NULL;
+
+    // Filter All Files
+    all_files.name = g_utf8_to_utf16(all_files_filter_name,
+        -1, NULL, &all_files.name_length, NULL);
+    all_files.filter = NULL;
+    all_files.filter_length = 0;
+    filter_list.push_front(all_files);
+    _extension_map[extension_index++] = NULL;
+
+    filter_length += all_files.name_length + 3 +
+                    all_inkscape_files.filter_length +
+                    all_inkscape_files.name_length + 3 +
+                    all_image_files.filter_length +
+                    all_image_files.name_length + 3 + 1;
+     // Add 3 for 2*2 \0s and a *, and 1 for a trailing \0
+
+
+    _filter = new wchar_t[filter_length];
+    wchar_t *filterptr = _filter;
+
+    for(list<Filter>::iterator filter_iterator = filter_list.begin();
+        filter_iterator != filter_list.end(); filter_iterator++)
+    {
+        const Filter &filter = *filter_iterator;
+
+        memcpy(filterptr, filter.name, filter.name_length * 2);
+        filterptr += filter.name_length;
+        g_free(filter.name);
+
+        *(filterptr++) = L'\0';
+        *(filterptr++) = L'*';
+
+        if(filter.filter != NULL)
+        {
+            memcpy(filterptr, filter.filter, filter.filter_length * 2);
+            filterptr += filter.filter_length;
+            g_free(filter.filter);
+        }
+
+        *(filterptr++) = L'\0';
+
+        // Associate this input extension with the file type name
+        _extension_map[extension_index++] = filter.mod;
+    }
+    *(filterptr++) = L'\0';
+
+    _filterIndex = 2;
+}
+
+void FileOpenDialogImplWin32::GetOpenFileName_thread()
+{
+    OPENFILENAMEEXW ofn;
+
+    g_assert(this != NULL);
+    //g_assert(_mutex != NULL);
+    g_assert(_main_loop != NULL);
+
+    WCHAR* current_directory_string = (WCHAR*)g_utf8_to_utf16(
+        _current_directory.data(), -1, NULL, NULL, NULL);
+
+    memset(&ofn, 0, sizeof(ofn));
+
+    // Copy the selected file name, converting from UTF-8 to UTF-16
+    memset(_path_string, 0, sizeof(_path_string));
+    gunichar2* utf16_path_string = g_utf8_to_utf16(
+        myFilename.data(), -1, NULL, NULL, NULL);
+    wcsncpy(_path_string, (wchar_t*)utf16_path_string, _MAX_PATH);
+    g_free(utf16_path_string);
+
+    ofn.lStructSize = sizeof(ofn);
+    ofn.hwndOwner = _ownerHwnd;
+    ofn.lpstrFile = _path_string;
+    ofn.nMaxFile = _MAX_PATH;
+    ofn.lpstrFileTitle = NULL;
+    ofn.nMaxFileTitle = 0;
+    ofn.lpstrInitialDir = current_directory_string;
+    ofn.lpstrTitle = _title;
+    ofn.Flags = OFN_PATHMUSTEXIST | OFN_FILEMUSTEXIST | OFN_EXPLORER | OFN_ENABLEHOOK | OFN_HIDEREADONLY | OFN_ENABLESIZING;
+    ofn.lpstrFilter = _filter;
+    ofn.nFilterIndex = _filterIndex;
+    ofn.lpfnHook = GetOpenFileName_hookproc;
+    ofn.lCustData = (LPARAM)this;
+
+    _result = GetOpenFileNameW(&ofn) != 0;
+
+    _filterIndex = ofn.nFilterIndex;
+    _extension = _extension_map[ofn.nFilterIndex];
+
+    myFilename = utf16_to_ustring(_path_string, _MAX_PATH);
+
+    // Copy the selected file name, converting from UTF-16 to UTF-8
+    myFilename = utf16_to_ustring(_path_string, _MAX_PATH);
+
+    // Tidy up
+    g_free(current_directory_string);
+
+    _mutex->lock();
+    _finished = true;
+    _mutex->unlock();
+    //g_main_loop_quit(_main_loop);
+
+
+}
+
+void FileOpenDialogImplWin32::register_preview_wnd_class()
+{
+    HINSTANCE hInstance = GetModuleHandle(NULL);
+    const WNDCLASSA PreviewWndClass =
+    {
+        CS_HREDRAW | CS_VREDRAW,
+        preview_wnd_proc,
+        0,
+        0,
+        hInstance,
+        NULL,
+        LoadCursor(hInstance, IDC_ARROW),
+        (HBRUSH)(COLOR_BTNFACE + 1),
+        NULL,
+        PreviewWindowClassName
+    };
+
+    RegisterClassA(&PreviewWndClass);
+}
+
+UINT_PTR CALLBACK FileOpenDialogImplWin32::GetOpenFileName_hookproc(
+    HWND hdlg, UINT uiMsg, WPARAM, LPARAM lParam)
+{
+    FileOpenDialogImplWin32 *pImpl = (FileOpenDialogImplWin32*)
+        GetWindowLongPtr(hdlg, GWLP_USERDATA);
+
+    switch(uiMsg)
+    {
+    case WM_INITDIALOG:
+        {
+            HWND hParentWnd = GetParent(hdlg);
+            HINSTANCE hInstance = GetModuleHandle(NULL);
+
+            // Make the window a bit wider
+            RECT rcRect;
+            GetWindowRect(hParentWnd, &rcRect);
+            MoveWindow(hParentWnd, rcRect.left, rcRect.top,
+                rcRect.right - rcRect.left + PreviewWidening,
+                rcRect.bottom - rcRect.top,
+                FALSE);
+
+            // Set the pointer to the object
+            OPENFILENAMEW *ofn = (OPENFILENAMEW*)lParam;
+            SetWindowLongPtr(hdlg, GWLP_USERDATA, ofn->lCustData);
+            SetWindowLongPtr(hParentWnd, GWLP_USERDATA, ofn->lCustData);
+            pImpl = (FileOpenDialogImplWin32*)ofn->lCustData;
+
+            // Subclass the parent
+            pImpl->_base_window_proc = (WNDPROC)GetWindowLongPtr(hParentWnd, GWL_WNDPROC);
+            SetWindowLongPtr(hParentWnd, GWL_WNDPROC, (LONG_PTR)file_dialog_subclass_proc);
+
+            // Add a button to the toolbar
+            pImpl->_toolbar_wnd = FindWindowEx(hParentWnd, NULL, "ToolbarWindow32", NULL);
+
+            pImpl->_show_preview_button_bitmap = LoadBitmap(
+                hInstance, MAKEINTRESOURCE(IDC_SHOW_PREVIEW));
+            TBADDBITMAP tbAddBitmap = {NULL, (UINT)pImpl->_show_preview_button_bitmap};
+            const int iBitmapIndex = SendMessage(pImpl->_toolbar_wnd,
+                TB_ADDBITMAP, 1, (LPARAM)&tbAddBitmap);
+
+            TBBUTTON tbButton;
+            memset(&tbButton, 0, sizeof(TBBUTTON));
+            tbButton.iBitmap = iBitmapIndex;
+            tbButton.idCommand = IDC_SHOW_PREVIEW;
+            tbButton.fsState = (pImpl->_show_preview ? TBSTATE_CHECKED : 0)
+                | TBSTATE_ENABLED;
+            tbButton.fsStyle = TBSTYLE_CHECK;
+            tbButton.iString = (INT_PTR)_("Show Preview");
+            SendMessage(pImpl->_toolbar_wnd, TB_ADDBUTTONS, 1, (LPARAM)&tbButton);
+
+            // Create preview pane
+            register_preview_wnd_class();
+
+            pImpl->_mutex->lock();
+
+                pImpl->_file_dialog_wnd = hParentWnd;
+
+                pImpl->_preview_wnd =
+                    CreateWindow(PreviewWindowClassName, "",
+                        WS_CHILD | WS_VISIBLE,
+                        0, 0, 100, 100, hParentWnd, NULL, hInstance, NULL);
+                SetWindowLongPtr(pImpl->_preview_wnd, GWLP_USERDATA, ofn->lCustData);
+
+            pImpl->_mutex->unlock();
+
+            pImpl->layout_dialog();
+        }
+        break;
+
+    case WM_NOTIFY:
+        {
+
+        OFNOTIFY *pOFNotify = reinterpret_cast<OFNOTIFY*>(lParam);
+        switch(pOFNotify->hdr.code)
+        {
+        case CDN_SELCHANGE:
+            {
+                if(pImpl != NULL)
+                {
+                    // Get the file name
+                    pImpl->_mutex->lock();
+
+                    SendMessage(pOFNotify->hdr.hwndFrom, CDM_GETFILEPATH,
+                        sizeof(pImpl->_path_string) / sizeof(wchar_t),
+                        (LPARAM)pImpl->_path_string);
+
+                    pImpl->_file_selected = true;
+
+                    pImpl->_mutex->unlock();
+
+                    //pImpl->file_selected();
+                }
+            }
+            break;
+        }
+        }
+        break;
+
+    case WM_CLOSE:
+        pImpl->_mutex->lock();
+        pImpl->_preview_file_size = 0;
+
+        pImpl->_file_dialog_wnd = NULL;
+        DestroyWindow(pImpl->_preview_wnd);
+        pImpl->_preview_wnd = NULL;
+        DeleteObject(pImpl->_show_preview_button_bitmap);
+        pImpl->_show_preview_button_bitmap = NULL;
+        pImpl->_mutex->unlock();
+
+        break;
+    }
+
+    // Use default dialog behaviour
+    return 0;
+}
+
+LRESULT CALLBACK FileOpenDialogImplWin32::file_dialog_subclass_proc(HWND hwnd, UINT uMsg, WPARAM wParam, LPARAM lParam)
+{
+    FileOpenDialogImplWin32 *pImpl = (FileOpenDialogImplWin32*)
+        GetWindowLongPtr(hwnd, GWLP_USERDATA);
+
+    LRESULT lResult = CallWindowProc(pImpl->_base_window_proc, hwnd, uMsg, wParam, lParam);
+
+    switch(uMsg)
+    {
+    case WM_SHOWWINDOW:
+        if(wParam != 0)
+            pImpl->layout_dialog();
+        break;
+
+    case WM_SIZE:
+        pImpl->layout_dialog();
+        break;
+
+    case WM_COMMAND:
+        if(wParam == IDC_SHOW_PREVIEW)
+        {
+            const bool enable = SendMessage(pImpl->_toolbar_wnd,
+                TB_ISBUTTONCHECKED, IDC_SHOW_PREVIEW, 0) != 0;
+            pImpl->enable_preview(enable);
+        }
+        break;
+    }
+
+    return lResult;
+}
+
+LRESULT CALLBACK FileOpenDialogImplWin32::preview_wnd_proc(HWND hwnd, UINT uMsg, WPARAM wParam, LPARAM lParam)
+{
+    const int CaptionPadding = 4;
+    const int IconSize = 32;
+
+    FileOpenDialogImplWin32 *pImpl = (FileOpenDialogImplWin32*)
+        GetWindowLongPtr(hwnd, GWLP_USERDATA);
+
+    LRESULT lResult = 0;
+
+    switch(uMsg)
+    {
+    case WM_ERASEBKGND:
+        // Do nothing to erase the background
+        //  - otherwise there'll be flicker
+        lResult = 1;
+        break;
+
+    case WM_PAINT:
+        {
+            // Get the client rect
+            RECT rcClient;
+            GetClientRect(hwnd, &rcClient);
+
+            // Prepare to paint
+            PAINTSTRUCT paint_struct;
+            HDC dc = BeginPaint(hwnd, &paint_struct);
+
+            HFONT hCaptionFont = (HFONT)SendMessage(GetParent(hwnd),
+                    WM_GETFONT, 0, 0);
+            HFONT hOldFont = (HFONT)SelectObject(dc, hCaptionFont);
+            SetBkMode(dc, TRANSPARENT);
+
+            pImpl->_mutex->lock();
+
+            //FillRect(dc, &client_rect, (HBRUSH)(COLOR_HOTLIGHT+1));
+            if(pImpl->_path_string[0] == 0)
+            {
+                FillRect(dc, &rcClient, (HBRUSH)(COLOR_3DFACE + 1));
+                DrawText(dc, _("No file selected"), -1, &rcClient,
+                    DT_CENTER | DT_VCENTER | DT_NOPREFIX);
+            }
+            else if(pImpl->_preview_bitmap != NULL)
+            {
+                BITMAP bitmap;
+                GetObject(pImpl->_preview_bitmap, sizeof(bitmap), &bitmap);
+                const int destX = (rcClient.right - bitmap.bmWidth) / 2;
+
+                // Render the image
+                HDC hSrcDC = CreateCompatibleDC(dc);
+                HBITMAP hOldBitmap = (HBITMAP)SelectObject(hSrcDC, pImpl->_preview_bitmap);
+
+                BitBlt(dc, destX, 0, bitmap.bmWidth, bitmap.bmHeight,
+                    hSrcDC, 0, 0, SRCCOPY);
+
+                SelectObject(hSrcDC, hOldBitmap);
+                DeleteDC(hSrcDC);
+
+                // Fill in the background area
+                HRGN hEraseRgn = CreateRectRgn(rcClient.left, rcClient.top,
+                    rcClient.right, rcClient.bottom);
+                HRGN hImageRgn = CreateRectRgn(destX, 0,
+                    destX + bitmap.bmWidth, bitmap.bmHeight);
+                CombineRgn(hEraseRgn, hEraseRgn, hImageRgn, RGN_DIFF);
+
+                FillRgn(dc, hEraseRgn, GetSysColorBrush(COLOR_3DFACE));
+
+                DeleteObject(hImageRgn);
+                DeleteObject(hEraseRgn);
+
+                // Draw the caption on
+                RECT rcCaptionRect = {rcClient.left,
+                    rcClient.top + bitmap.bmHeight + CaptionPadding,
+                    rcClient.right, rcClient.bottom};
+
+                WCHAR szCaption[_MAX_FNAME + 32];
+                const int iLength = pImpl->format_caption(
+                    szCaption, sizeof(szCaption) / sizeof(WCHAR));
+
+                DrawTextW(dc, szCaption, iLength, &rcCaptionRect,
+                    DT_CENTER | DT_TOP | DT_NOPREFIX | DT_PATH_ELLIPSIS);
+            }
+            else if(pImpl->_preview_file_icon != NULL)
+            {
+                FillRect(dc, &rcClient, (HBRUSH)(COLOR_3DFACE + 1));
+
+                // Draw the files icon
+                const int destX = (rcClient.right - IconSize) / 2;
+                DrawIconEx(dc, destX, 0, pImpl->_preview_file_icon,
+                    IconSize, IconSize, 0, NULL,
+                    DI_NORMAL | DI_COMPAT);
+
+                // Draw the caption on
+                RECT rcCaptionRect = {rcClient.left,
+                    rcClient.top + IconSize + CaptionPadding,
+                    rcClient.right, rcClient.bottom};
+
+                WCHAR szFileName[_MAX_FNAME], szCaption[_MAX_FNAME + 32];
+                _wsplitpath(pImpl->_path_string, NULL, NULL, szFileName, NULL);
+
+                const int iLength = snwprintf(szCaption,
+                    sizeof(szCaption), L"%s\n%d kB",
+                    szFileName, pImpl->_preview_file_size);
+
+                DrawTextW(dc, szCaption, iLength, &rcCaptionRect,
+                    DT_CENTER | DT_TOP | DT_NOPREFIX | DT_PATH_ELLIPSIS);
+            }
+            else
+            {
+                // Can't show anything!
+                FillRect(dc, &rcClient, (HBRUSH)(COLOR_3DFACE + 1));
+            }
+
+            pImpl->_mutex->unlock();
+
+            // Finish painting
+            SelectObject(dc, hOldFont);
+            EndPaint(hwnd, &paint_struct);
+        }
+
+        break;
+
+    case WM_DESTROY:
+        pImpl->free_preview();
+        break;
+
+    default:
+        lResult = DefWindowProc(hwnd, uMsg, wParam, lParam);
+        break;
+    }
+
+    return lResult;
+}
+
+void FileOpenDialogImplWin32::enable_preview(bool enable)
+{
+    _show_preview = enable;
+
+    // Relayout the dialog
+    ShowWindow(_preview_wnd, enable ? SW_SHOW : SW_HIDE);
+    layout_dialog();
+
+    // Load or unload the preview
+    if(enable)
+    {
+        _mutex->lock();
+        _file_selected = true;
+        _mutex->unlock();
+    }
+    else free_preview();
+}
+
+void FileOpenDialogImplWin32::layout_dialog()
+{
+    union RECTPOINTS
+    {
+        RECT r;
+        POINT p[2];
+    };
+
+    const float MaxExtentScale = 2.0f / 3.0f;
+
+    RECT rcClient;
+    GetClientRect(_file_dialog_wnd, &rcClient);
+
+    // Re-layout the dialog
+    HWND hFileListWnd = GetDlgItem(_file_dialog_wnd, lst2);
+    HWND hFolderComboWnd = GetDlgItem(_file_dialog_wnd, cmb2);
+
+
+    RECT rcFolderComboRect;
+    RECTPOINTS rcFileList;
+    GetWindowRect(hFileListWnd, &rcFileList.r);
+    GetWindowRect(hFolderComboWnd, &rcFolderComboRect);
+    const int iPadding = rcFileList.r.top - rcFolderComboRect.bottom;
+    MapWindowPoints(NULL, _file_dialog_wnd, rcFileList.p, 2);
+
+    RECT rcPreview;
+    RECT rcBody = {rcFileList.r.left, rcFileList.r.top,
+        rcClient.right - iPadding, rcFileList.r.bottom};
+    rcFileList.r.right = rcBody.right;
+
+    if(_show_preview)
+    {
+        rcPreview.top = rcBody.top;
+        rcPreview.left = rcClient.right - (rcBody.bottom - rcBody.top);
+        const int iMaxExtent = (int)(MaxExtentScale * (float)(rcBody.left + rcBody.right)) + iPadding / 2;
+        if(rcPreview.left < iMaxExtent) rcPreview.left = iMaxExtent;
+        rcPreview.bottom = rcBody.bottom;
+        rcPreview.right = rcBody.right;
+
+        // Re-layout the preview box
+        _mutex->lock();
+
+            _preview_width = rcPreview.right - rcPreview.left;
+            _preview_height = rcPreview.bottom - rcPreview.top;
+
+        _mutex->unlock();
+
+        render_preview();
+
+        MoveWindow(_preview_wnd, rcPreview.left, rcPreview.top,
+            _preview_width, _preview_height, TRUE);
+
+        rcFileList.r.right = rcPreview.left - iPadding;
+    }
+
+    // Re-layout the file list box
+    MoveWindow(hFileListWnd, rcFileList.r.left, rcFileList.r.top,
+        rcFileList.r.right - rcFileList.r.left,
+        rcFileList.r.bottom - rcFileList.r.top, TRUE);
+
+    // Re-layout the toolbar
+    RECTPOINTS rcToolBar;
+    GetWindowRect(_toolbar_wnd, &rcToolBar.r);
+    MapWindowPoints(NULL, _file_dialog_wnd, rcToolBar.p, 2);
+    MoveWindow(_toolbar_wnd, rcToolBar.r.left, rcToolBar.r.top,
+        rcToolBar.r.right - rcToolBar.r.left, rcToolBar.r.bottom - rcToolBar.r.top, TRUE);
+}
+
+void FileOpenDialogImplWin32::file_selected()
+{
+    // Destroy any previous previews
+    free_preview();
+
+
+    // Determine if the file exists
+    DWORD attributes = GetFileAttributesW(_path_string);
+    if(attributes == 0xFFFFFFFF ||
+        attributes == FILE_ATTRIBUTE_DIRECTORY)
+    {
+        InvalidateRect(_preview_wnd, NULL, FALSE);
+        return;
+    }
+
+    // Check the file exists and get the file size
+    HANDLE file_handle = CreateFileW(_path_string, GENERIC_READ,
+        FILE_SHARE_READ, NULL, OPEN_EXISTING, FILE_ATTRIBUTE_NORMAL, NULL);
+    if(file_handle == INVALID_HANDLE_VALUE) return;
+    const DWORD file_size = GetFileSize(file_handle, NULL);
+    if (file_size == INVALID_FILE_SIZE) return;
+    _preview_file_size = file_size / 1024;
+    CloseHandle(file_handle);
+
+    if(_show_preview) load_preview();
+}
+
+void FileOpenDialogImplWin32::load_preview()
+{
+    // Destroy any previous previews
+    free_preview();
+
+    // Try to get the file icon
+    SHFILEINFOW fileInfo;
+    if(SUCCEEDED(SHGetFileInfoW(_path_string, 0, &fileInfo,
+        sizeof(fileInfo), SHGFI_ICON | SHGFI_LARGEICON)))
+        _preview_file_icon = fileInfo.hIcon;
+
+    // Will this file be too big?
+    if(_preview_file_size > MaxPreviewFileSize)
+    {
+        InvalidateRect(_preview_wnd, NULL, FALSE);
+        return;
+    }
+
+    // Prepare to render a preview
+    const Glib::ustring svg = ".svg";
+    const Glib::ustring svgz = ".svgz";
+    const Glib::ustring path = utf16_to_ustring(_path_string);
+
+    bool success = false;
+
+    _preview_document_width = _preview_document_height = 0;
+
+    if ((dialogType == SVG_TYPES || dialogType == IMPORT_TYPES) &&
+            (hasSuffix(path, svg) || hasSuffix(path, svgz)))
+        success = set_svg_preview();
+    else if (isValidImageFile(path))
+        success = set_image_preview();
+    else {
+        // Show no preview
+    }
+
+    if(success) render_preview();
+
+    InvalidateRect(_preview_wnd, NULL, FALSE);
+}
+
+void FileOpenDialogImplWin32::free_preview()
+{
+    _mutex->lock();
+    if(_preview_bitmap != NULL)
+        DeleteObject(_preview_bitmap);
+    _preview_bitmap = NULL;
+
+    if(_preview_file_icon != NULL)
+        DestroyIcon(_preview_file_icon);
+    _preview_file_icon = NULL;
+
+    _preview_bitmap_image.clear();
+    _mutex->unlock();
+}
+
+bool FileOpenDialogImplWin32::set_svg_preview()
+{
+    const int PreviewSize = 512;
+
+    gchar *utf8string = g_utf16_to_utf8((const gunichar2*)_path_string,
+        _MAX_PATH, NULL, NULL, NULL);
+    SPDocument *svgDoc = sp_document_new (utf8string, true);
+    g_free(utf8string);
+
+    // Check the document loaded properly
+    if(svgDoc == NULL) return false;
+    if(svgDoc->root == NULL)
+    {
+        sp_document_unref(svgDoc);
+        return false;
+    }
+
+    // Get the size of the document
+    const double svgWidth = sp_document_width(svgDoc);
+    const double svgHeight = sp_document_height(svgDoc);
+
+    // Find the minimum scale to fit the image inside the preview area
+    const double scaleFactorX =    PreviewSize / svgWidth;
+    const double scaleFactorY =    PreviewSize / svgHeight;
+    const double scaleFactor = (scaleFactorX > scaleFactorY) ? scaleFactorY : scaleFactorX;
+
+    // Now get the resized values
+    const double scaledSvgWidth  = scaleFactor * svgWidth;
+    const double scaledSvgHeight = scaleFactor * svgHeight;
+
+    NR::Rect area(NR::Point(0, 0), NR::Point(scaledSvgWidth, scaledSvgHeight));
+    NRRectL areaL = {0, 0, scaledSvgWidth, scaledSvgHeight};
+    NRRectL bbox = {0, 0, scaledSvgWidth, scaledSvgHeight};
+
+    // write object bbox to area
+    NR::Maybe<NR::Rect> maybeArea(area);
+    sp_document_ensure_up_to_date (svgDoc);
+    sp_item_invoke_bbox((SPItem *) svgDoc->root, &maybeArea,
+        sp_item_i2r_affine((SPItem *)(svgDoc->root)), TRUE);
+
+    NRArena *const arena = NRArena::create();
+
+    unsigned const key = sp_item_display_key_new(1);
+
+    NRArenaItem *root = sp_item_invoke_show((SPItem*)(svgDoc->root),
+        arena, key, SP_ITEM_SHOW_DISPLAY);
+
+    NRGC gc(NULL);
+    nr_matrix_set_scale(&gc.transform, scaleFactor, scaleFactor);
+
+    nr_arena_item_invoke_update (root, NULL, &gc,
+        NR_ARENA_ITEM_STATE_ALL, NR_ARENA_ITEM_STATE_NONE);
+
+    // Prepare a GDI compatible NRPixBlock
+    NRPixBlock pixBlock;
+    pixBlock.size = NR_PIXBLOCK_SIZE_BIG;
+    pixBlock.mode = NR_PIXBLOCK_MODE_R8G8B8;
+    pixBlock.empty = 1;
+    pixBlock.visible_area.x0 = pixBlock.area.x0 = 0;
+    pixBlock.visible_area.y0 = pixBlock.area.y0 = 0;
+    pixBlock.visible_area.x1 = pixBlock.area.x1 = scaledSvgWidth;
+    pixBlock.visible_area.y1 = pixBlock.area.y1 = scaledSvgHeight;
+    pixBlock.rs = 4 * ((3 * (int)scaledSvgWidth + 3) / 4);
+    pixBlock.data.px = g_try_new (unsigned char, pixBlock.rs * scaledSvgHeight);
+
+    // Fail if the pixblock failed to allocate
+    if(pixBlock.data.px == NULL)
+    {
+        sp_document_unref(svgDoc);
+        return false;
+    }
+
+    memset(pixBlock.data.px, 0xFF, pixBlock.rs * scaledSvgHeight);
+
+    memcpy(&root->bbox, &areaL, sizeof(areaL));
+
+    // Render the image
+    nr_arena_item_invoke_render(NULL, root, &bbox, &pixBlock, /*0*/NR_ARENA_ITEM_RENDER_NO_CACHE);
+
+    // Tidy up
+    sp_document_unref(svgDoc);
+    sp_item_invoke_hide((SPItem*)(svgDoc->root), key);
+    nr_arena_item_unref(root);
+    nr_object_unref((NRObject *) arena);
+
+    // Create the GDK pixbuf
+    _mutex->lock();
+
+    _preview_bitmap_image = Gdk::Pixbuf::create_from_data(
+        pixBlock.data.px, Gdk::COLORSPACE_RGB, false, 8,
+        (int)scaledSvgWidth, (int)scaledSvgHeight, pixBlock.rs,
+        sigc::ptr_fun(destroy_svg_rendering));
+
+    _preview_document_width = scaledSvgWidth;
+    _preview_document_height = scaledSvgHeight;
+    _preview_image_width = svgWidth;
+    _preview_image_height = svgHeight;
+
+    _mutex->unlock();
+
+    return true;
+}
+
+void FileOpenDialogImplWin32::destroy_svg_rendering(const guint8 *buffer)
+{
+    g_assert(buffer != NULL);
+    g_free((void*)buffer);
+}
+
+bool FileOpenDialogImplWin32::set_image_preview()
+{
+    const Glib::ustring path = utf16_to_ustring(_path_string, _MAX_PATH);
+
+    _mutex->lock();
+    _preview_bitmap_image = Gdk::Pixbuf::create_from_file(path);
+    if(!_preview_bitmap_image) return false;
+
+    _preview_image_width = _preview_bitmap_image->get_width();
+    _preview_document_width = _preview_image_width;
+    _preview_image_height = _preview_bitmap_image->get_height();
+    _preview_document_height = _preview_image_height;
+
+    _mutex->unlock();
+
+    return true;
+}
+
+void FileOpenDialogImplWin32::render_preview()
+{
+    double x, y;
+    const double blurRadius = 8;
+    const double halfBlurRadius = blurRadius / 2;
+    const int shaddowOffsetX = 0;
+    const int shaddowOffsetY = 2;
+    const int pagePadding = 5;
+    const double shaddowAlpha = 0.75;
+
+    // Is the preview showing?
+    if(!_show_preview)
+        return;
+
+    // Do we have anything to render?
+    _mutex->lock();
+
+    if(!_preview_bitmap_image)
+    {
+        _mutex->unlock();
+        return;
+    }
+
+    // Tidy up any previous bitmap renderings
+    if(_preview_bitmap != NULL)
+        DeleteObject(_preview_bitmap);
+    _preview_bitmap = NULL;
+
+    // Calculate the size of the caption
+    int captionHeight = 0;
+
+    if(_preview_wnd != NULL)
+    {
+        RECT rcCaptionRect;
+        WCHAR szCaption[_MAX_FNAME + 32];
+        const int iLength = format_caption(szCaption,
+            sizeof(szCaption) / sizeof(WCHAR));
+
+        HDC dc = GetDC(_preview_wnd);
+        DrawTextW(dc, szCaption, iLength, &rcCaptionRect,
+            DT_CENTER | DT_TOP | DT_NOPREFIX | DT_PATH_ELLIPSIS | DT_CALCRECT);
+        ReleaseDC(_preview_wnd, dc);
+
+        captionHeight = rcCaptionRect.bottom - rcCaptionRect.top;
+    }
+
+    // Find the minimum scale to fit the image inside the preview area
+    const double scaleFactorX =
+        ((double)_preview_width - pagePadding * 2 - blurRadius)  / _preview_document_width;
+    const double scaleFactorY =
+        ((double)_preview_height - pagePadding * 2
+        - shaddowOffsetY - halfBlurRadius - captionHeight) / _preview_document_height;
+    double scaleFactor = (scaleFactorX > scaleFactorY) ? scaleFactorY : scaleFactorX;
+    scaleFactor = (scaleFactor > 1.0) ? 1.0 : scaleFactor;
+
+    // Now get the resized values
+    const double scaledSvgWidth  = scaleFactor * _preview_document_width;
+    const double scaledSvgHeight = scaleFactor * _preview_document_height;
+
+    const int svgX = pagePadding + halfBlurRadius;
+    const int svgY = pagePadding;
+
+    const int frameX = svgX - pagePadding;
+    const int frameY = svgY - pagePadding;
+    const int frameWidth = scaledSvgWidth + pagePadding * 2;
+    const int frameHeight = scaledSvgHeight + pagePadding * 2;
+
+    const int totalWidth = (int)ceil(frameWidth + blurRadius);
+    const int totalHeight = (int)ceil(frameHeight + blurRadius);
+
+    // Prepare the drawing surface
+    HDC hDC = GetDC(_preview_wnd);
+    HDC hMemDC = CreateCompatibleDC(hDC);
+    _preview_bitmap = CreateCompatibleBitmap(hDC, totalWidth, totalHeight);
+    HBITMAP hOldBitmap = (HBITMAP)SelectObject(hMemDC, _preview_bitmap);
+    Cairo::RefPtr<Win32Surface> surface = Win32Surface::create(hMemDC);
+    Cairo::RefPtr<Context> context = Context::create(surface);
+
+    // Paint the background to match the dialog colour
+    const COLORREF background = GetSysColor(COLOR_3DFACE);
+    context->set_source_rgb(
+        GetRValue(background) / 255.0,
+        GetGValue(background) / 255.0,
+        GetBValue(background) / 255.0);
+    context->paint();
+
+    //----- Draw the drop shaddow -----//
+
+    // Left Edge
+    x = frameX + shaddowOffsetX - halfBlurRadius;
+    Cairo::RefPtr<LinearGradient> leftEdgeFade = LinearGradient::create(
+        x, 0.0, x + blurRadius, 0.0);
+    leftEdgeFade->add_color_stop_rgba (0, 0, 0, 0, 0);
+    leftEdgeFade->add_color_stop_rgba (1, 0, 0, 0, shaddowAlpha);
+    context->set_source(leftEdgeFade);
+    context->rectangle (x, frameY + shaddowOffsetY + halfBlurRadius,
+        blurRadius, frameHeight - blurRadius);
+    context->fill();
+
+    // Right Edge
+    x = frameX + frameWidth + shaddowOffsetX - halfBlurRadius;
+    Cairo::RefPtr<LinearGradient> rightEdgeFade = LinearGradient::create(
+        x, 0.0,    x + blurRadius, 0.0);
+    rightEdgeFade->add_color_stop_rgba (0, 0, 0, 0, shaddowAlpha);
+    rightEdgeFade->add_color_stop_rgba (1, 0, 0, 0, 0);
+    context->set_source(rightEdgeFade);
+    context->rectangle (frameX + frameWidth + shaddowOffsetX - halfBlurRadius,
+        frameY + shaddowOffsetY + halfBlurRadius,
+        blurRadius, frameHeight - blurRadius);
+    context->fill();
+
+    // Top Edge
+    y = frameY + shaddowOffsetY - halfBlurRadius;
+    Cairo::RefPtr<LinearGradient> topEdgeFade = LinearGradient::create(
+        0.0, y, 0.0, y + blurRadius);
+    topEdgeFade->add_color_stop_rgba (0, 0, 0, 0, 0);
+    topEdgeFade->add_color_stop_rgba (1, 0, 0, 0, shaddowAlpha);
+    context->set_source(topEdgeFade);
+    context->rectangle (frameX + shaddowOffsetX + halfBlurRadius, y,
+        frameWidth - blurRadius, blurRadius);
+    context->fill();
+
+    // Bottom Edge
+    y = frameY + frameHeight + shaddowOffsetY - halfBlurRadius;
+    Cairo::RefPtr<LinearGradient> bottomEdgeFade = LinearGradient::create(
+        0.0, y,    0.0, y + blurRadius);
+    bottomEdgeFade->add_color_stop_rgba (0, 0, 0, 0, shaddowAlpha);
+    bottomEdgeFade->add_color_stop_rgba (1, 0, 0, 0, 0);
+    context->set_source(bottomEdgeFade);
+    context->rectangle (frameX + shaddowOffsetX + halfBlurRadius, y,
+        frameWidth - blurRadius, blurRadius);
+    context->fill();
+
+    // Top Left Corner
+    x = frameX + shaddowOffsetX - halfBlurRadius;
+    y = frameY + shaddowOffsetY - halfBlurRadius;
+    Cairo::RefPtr<RadialGradient> topLeftCornerFade = RadialGradient::create(
+        x + blurRadius, y + blurRadius, 0, x + blurRadius, y + blurRadius, blurRadius);
+    topLeftCornerFade->add_color_stop_rgba (0, 0, 0, 0, shaddowAlpha);
+    topLeftCornerFade->add_color_stop_rgba (1, 0, 0, 0, 0);
+    context->set_source(topLeftCornerFade);
+    context->rectangle (x, y, blurRadius, blurRadius);
+    context->fill();
+
+    // Top Right Corner
+    x = frameX + frameWidth + shaddowOffsetX - halfBlurRadius;
+    y = frameY + shaddowOffsetY - halfBlurRadius;
+    Cairo::RefPtr<RadialGradient> topRightCornerFade = RadialGradient::create(
+        x, y + blurRadius, 0, x, y + blurRadius, blurRadius);
+    topRightCornerFade->add_color_stop_rgba (0, 0, 0, 0, shaddowAlpha);
+    topRightCornerFade->add_color_stop_rgba (1, 0, 0, 0, 0);
+    context->set_source(topRightCornerFade);
+    context->rectangle (x, y, blurRadius, blurRadius);
+    context->fill();
+
+    // Bottom Left Corner
+    x = frameX + shaddowOffsetX - halfBlurRadius;
+    y = frameY + frameHeight + shaddowOffsetY - halfBlurRadius;
+    Cairo::RefPtr<RadialGradient> bottomLeftCornerFade = RadialGradient::create(
+        x + blurRadius, y, 0, x + blurRadius, y, blurRadius);
+    bottomLeftCornerFade->add_color_stop_rgba (0, 0, 0, 0, shaddowAlpha);
+    bottomLeftCornerFade->add_color_stop_rgba (1, 0, 0, 0, 0);
+    context->set_source(bottomLeftCornerFade);
+    context->rectangle (x, y, blurRadius, blurRadius);
+    context->fill();
+
+    // Bottom Right Corner
+    x = frameX + frameWidth + shaddowOffsetX - halfBlurRadius;
+    y = frameY + frameHeight + shaddowOffsetY - halfBlurRadius;
+    Cairo::RefPtr<RadialGradient> bottomRightCornerFade = RadialGradient::create(
+        x, y, 0, x, y, blurRadius);
+    bottomRightCornerFade->add_color_stop_rgba (0, 0, 0, 0, shaddowAlpha);
+    bottomRightCornerFade->add_color_stop_rgba (1, 0, 0, 0, 0);
+    context->set_source(bottomRightCornerFade);
+    context->rectangle (frameX + frameWidth + shaddowOffsetX - halfBlurRadius,
+        frameY + frameHeight + shaddowOffsetY - halfBlurRadius,
+        blurRadius, blurRadius);
+    context->fill();
+
+    // Draw the frame
+    context->set_line_width(1);
+    context->rectangle (frameX, frameY,    frameWidth, frameHeight);
+
+    context->set_source_rgb(1.0, 1.0, 1.0);
+    context->fill_preserve();
+    context->set_source_rgb(0.25, 0.25, 0.25);
+    context->stroke_preserve();
+
+    // Draw the image
+
+    if(_preview_bitmap_image)    // Is the image a pixbuf?
+    {
+        // Set the transformation
+        const Matrix matrix = {
+            scaleFactor, 0,
+            0, scaleFactor,
+            svgX, svgY };
+        context->set_matrix (matrix);
+
+        // Render the image
+        set_source_pixbuf (context, _preview_bitmap_image, 0, 0);
+        context->paint();
+
+        // Reset the transformation
+        context->set_identity_matrix();
+    }
+
+    // Draw the inner frame
+    context->set_source_rgb(0.75, 0.75, 0.75);
+    context->rectangle (svgX, svgY,    scaledSvgWidth, scaledSvgHeight);
+    context->stroke();
+
+    _mutex->unlock();
+
+    // Finish drawing
+    surface->finish();
+    SelectObject(hMemDC, hOldBitmap) ;
+    DeleteDC(hMemDC);
+
+    // Refresh the preview pane
+    InvalidateRect(_preview_wnd, NULL, FALSE);
+}
+
+int FileOpenDialogImplWin32::format_caption(wchar_t *caption, int caption_size)
+{
+    wchar_t szFileName[_MAX_FNAME];
+    _wsplitpath(_path_string, NULL, NULL, szFileName, NULL);
+
+    return snwprintf(caption, caption_size,
+        L"%s\n%d kB\n%d \xD7 %d", szFileName, _preview_file_size,
+        (int)_preview_document_width, (int)_preview_document_height);
+}
+
+/**
+ * Show this dialog modally.  Return true if user hits [OK]
+ */
+bool
+FileOpenDialogImplWin32::show()
+{
+    // We can only run one worker thread at a time
+    //if(_mutex != NULL) return false;
+
+    if(!Glib::thread_supported())
+        Glib::thread_init();
+
+    _result = false;
+    _finished = false;
+    _file_selected = false;
+    _mutex = new Glib::Mutex();
+    _main_loop = g_main_loop_new(g_main_context_default(), FALSE);
+
+    if(Glib::Thread::create(sigc::mem_fun(*this, &FileOpenDialogImplWin32::GetOpenFileName_thread), true))
+    {
+        while(1)
+        {
+            g_main_context_iteration(g_main_context_default(), FALSE);
+
+            if(_mutex->trylock())
+            {
+                // Read mutexed data
+                const bool finished = _finished;
+                const bool is_file_selected = _file_selected;
+                _file_selected = false;
+                _mutex->unlock();
+
+                if(finished) break;
+                if(is_file_selected) file_selected();
+            }
+
+            Sleep(10);
+        }
+        //g_main_loop_run(_main_loop);
+    }
+
+    // Tidy up
+    delete _mutex;
+    _mutex = NULL;
+
+    return _result;
+}
+
+/**
+ * To Get Multiple filenames selected at-once.
+ */
+std::vector<Glib::ustring>FileOpenDialogImplWin32::getFilenames()
+{
+    std::vector<Glib::ustring> result;
+    result.push_back(getFilename());
+    return result;
+}
+
+
+/*#########################################################################
+### F I L E    S A V E
+#########################################################################*/
+
+/**
+ * Constructor
+ */
+FileSaveDialogImplWin32::FileSaveDialogImplWin32(Gtk::Window &parent,
+            const Glib::ustring &dir,
+            FileDialogType fileTypes,
+            const char *title,
+            const Glib::ustring &/*default_key*/) :
+    FileDialogBaseWin32(parent, dir, title, fileTypes, "dialogs.save_as")
+{
+    _main_loop = NULL;
+
+    createFilterMenu();
+}
+
+FileSaveDialogImplWin32::~FileSaveDialogImplWin32()
+{
+}
+
+void FileSaveDialogImplWin32::createFilterMenu()
+{
+    list<Filter> filter_list;
+
+    knownExtensions.clear();
+
+    // Compose the filter string
+    Glib::ustring all_inkscape_files_filter, all_image_files_filter;
+    Inkscape::Extension::DB::OutputList extension_list;
+    Inkscape::Extension::db.get_output_list(extension_list);
+
+    int filter_count = 0;
+    int filter_length = 0;
+
+    for (Inkscape::Extension::DB::OutputList::iterator current_item = extension_list.begin();
+         current_item != extension_list.end(); current_item++)
+    {
+        Inkscape::Extension::Output *omod = *current_item;
+        if (omod->deactivated()) continue;
+
+        filter_count++;
+
+        Filter filter;
+
+        // Extension
+        const gchar *filter_extension = omod->get_extension();
+        filter.filter = g_utf8_to_utf16(
+            filter_extension, -1, NULL, &filter.filter_length, NULL);
+        knownExtensions.insert( Glib::ustring(filter_extension).casefold() );
+
+        // Type
+        filter.name = g_utf8_to_utf16(
+            omod->get_filetypename(), -1, NULL, &filter.name_length, NULL);
+
+        filter.mod = omod;
+
+        filter_length += filter.name_length +
+            filter.filter_length + 3;   // Add 3 for two \0s and a *
+
+        filter_list.push_back(filter);
+    }
+
+    int extension_index = 0;
+    _extension_map = new Inkscape::Extension::Extension*[filter_count];
+
+    _filter = new wchar_t[filter_length];
+    wchar_t *filterptr = _filter;
+
+    for(list<Filter>::iterator filter_iterator = filter_list.begin();
+        filter_iterator != filter_list.end(); filter_iterator++)
+    {
+        const Filter &filter = *filter_iterator;
+
+        memcpy(filterptr, filter.name, filter.name_length * 2);
+        filterptr += filter.name_length;
+        g_free(filter.name);
+
+        *(filterptr++) = L'\0';
+        *(filterptr++) = L'*';
+
+        memcpy(filterptr, filter.filter, filter.filter_length * 2);
+        filterptr += filter.filter_length;
+        g_free(filter.filter);
+
+        *(filterptr++) = L'\0';
+
+        // Associate this input extension with the file type name
+        _extension_map[extension_index++] = filter.mod;
+    }
+    *(filterptr++) = 0;
+
+    _filterIndex = 0;
+}
+
+void FileSaveDialogImplWin32::GetSaveFileName_thread()
+{
+    OPENFILENAMEEXW ofn;
+
+    g_assert(this != NULL);
+    //g_assert(_mutex != NULL);
+    g_assert(_main_loop != NULL);
+
+    gunichar2* current_directory_string = g_utf8_to_utf16(
+        _current_directory.data(), -1, NULL, NULL, NULL);
+
+    // Copy the selected file name, converting from UTF-8 to UTF-16
+    memset(_path_string, 0, sizeof(_path_string));
+    gunichar2* utf16_path_string = g_utf8_to_utf16(
+        myFilename.data(), -1, NULL, NULL, NULL);
+    wcsncpy(_path_string, (wchar_t*)utf16_path_string, _MAX_PATH);
+    g_free(utf16_path_string);
+
+    ZeroMemory(&ofn, sizeof(ofn));
+    ofn.lStructSize = sizeof(ofn);
+    ofn.hwndOwner = _ownerHwnd;
+    ofn.lpstrFile = _path_string;
+    ofn.nMaxFile = _MAX_PATH;
+    ofn.nFilterIndex = _filterIndex;
+    ofn.lpstrFileTitle = NULL;
+    ofn.nMaxFileTitle = 0;
+    ofn.lpstrInitialDir = (wchar_t*)current_directory_string;
+    ofn.lpstrTitle = _title;
+    ofn.Flags = OFN_PATHMUSTEXIST | OFN_FILEMUSTEXIST;
+    ofn.lpstrFilter = _filter;
+    ofn.nFilterIndex = _filterIndex;
+
+    _result = GetSaveFileNameW(&ofn) != 0;
+
+    _filterIndex = ofn.nFilterIndex;
+    _extension = _extension_map[ofn.nFilterIndex];
+
+    // Copy the selected file name, converting from UTF-16 to UTF-8
+    myFilename = utf16_to_ustring(_path_string, _MAX_PATH);
+
+    //_mutex->lock();
+    //_finished = true;
+    //_mutex->unlock();
+
+
+    // Tidy up
+    g_free(current_directory_string);
+
+    g_main_loop_quit(_main_loop);
+}
+
+/**
+ * Show this dialog modally.  Return true if user hits [OK]
+ */
+bool
+FileSaveDialogImplWin32::show()
+{
+    // We can only run one worker thread at a time
+    //if(_mutex != NULL) return false;
+
+    if(!Glib::thread_supported())
+        Glib::thread_init();
+
+    _result = false;
+    //_finished = false;
+    //_mutex = new Glib::Mutex();
+    _main_loop = g_main_loop_new(g_main_context_default(), FALSE);
+
+    if(Glib::Thread::create(sigc::mem_fun(*this, &FileSaveDialogImplWin32::GetSaveFileName_thread), true))
+    {
+        /*while(1)
+        {
+            // While the dialog runs - keep the main UI alive
+            g_main_context_iteration(g_main_context_default(), FALSE);
+
+            if(_mutex->trylock())
+            {
+                if(_finished) break;
+                _mutex->unlock();
+            }
+
+            Sleep(10);
+        }*/
+        g_main_loop_run(_main_loop);
+    }
+    //delete _mutex;
+    //_mutex = NULL;
+
+    if(_result)
+        appendExtension(myFilename, (Inkscape::Extension::Output*)_extension);
+
+    return _result;
+}
+
+void FileSaveDialogImplWin32::setSelectionType( Inkscape::Extension::Extension * /*key*/ )
+{
+    // If no pointer to extension is passed in, look up based on filename extension.
+
+}
+
+}
+}
+}
+
+#endif
+
+/*
+  Local Variables:
+  mode:c++
+  c-file-style:"stroustrup"
+  c-file-offsets:((innamespace . 0)(inline-open . 0)(case-label . +))
+  indent-tabs-mode:nil
+  fill-column:99
+  End:
+*/
+// vim: filetype=cpp:expandtab:shiftwidth=4:tabstop=8:softtabstop=4 :
index cf696c229f8cf795c54e0690eb2bd78cdf704415..fd0d1c259a8c04175b8e6ecb6bd923ce1d73ef7f 100644 (file)
-/**\r
- * Implementation of the file dialog interfaces defined in filedialog.h for Win32\r
- *\r
- * Authors:\r
- *   Joel Holdsworth\r
- *   The Inkscape Organization\r
- *\r
- * Copyright (C) 2004-2008 The Inkscape Organization\r
- *\r
- * Released under GNU GPL, read the file 'COPYING' for more information\r
- */\r
\r
-#ifdef WIN32\r
-\r
-#include "gc-core.h"\r
-#include <windows.h>\r
-\r
-namespace Inkscape\r
-{\r
-namespace UI\r
-{\r
-namespace Dialog\r
-{\r
-\r
-/*#########################################################################\r
-### F I L E     D I A L O G    B A S E    C L A S S\r
-#########################################################################*/\r
-\r
-/// This class is the base implementation of a MS Windows\r
-/// file dialog.\r
-class FileDialogBaseWin32\r
-{\r
-protected:\r
-    /// Abstract Constructor\r
-    /// @param parent The parent window for the dialog\r
-    /// @param dir The directory to begin browing from\r
-    /// @param title The title caption for the dialog in UTF-8\r
-    /// @param type The dialog type\r
-    /// @param preferenceBase The preferences key\r
-    FileDialogBaseWin32(Gtk::Window &parent, const Glib::ustring &dir,\r
-        const char *title, FileDialogType type,\r
-        gchar const *preferenceBase);\r
-\r
-    /// Destructor\r
-    ~FileDialogBaseWin32();\r
-    \r
-public:\r
-\r
-    /// Gets the currently selected extension. Valid after an [OK]\r
-    /// @return Returns a pointer to the selected extension, or NULL\r
-    /// if the selected filter requires an automatic type detection\r
-    Inkscape::Extension::Extension* getSelectionType();\r
-    \r
-    /// Get the path of the current directory\r
-    Glib::ustring getCurrentDirectory();\r
\r
-protected:\r
-    /// The dialog type\r
-    FileDialogType dialogType;\r
-    \r
-    /// This mutex is used to ensure that the worker thread\r
-    /// that calls GetOpenFileName cannot collide with the\r
-    /// main Inkscape thread\r
-    Glib::Mutex *_mutex;\r
-    \r
-    /// This flag is set true when the GetOpenFileName call\r
-    /// has returned\r
-    bool _finished;\r
-    \r
-    /// A pointer to the GTK main-loop context object. This\r
-    /// is used to keep the rest of the inkscape UI running\r
-    /// while the file dialog is displayed\r
-    GMainLoop *_main_loop;\r
-    \r
-    /// The result of the call to GetOpenFileName. If true\r
-    /// the user clicked OK, if false the user clicked cancel\r
-    bool _result;\r
-    \r
-    /// The parent window\r
-    Gtk::Window &parent;\r
-    \r
-    /// The windows handle of the parent window\r
-    HWND _ownerHwnd;\r
-    \r
-    /// The path of the directory that is currently being\r
-    /// browsed\r
-    Glib::ustring _current_directory;\r
-    \r
-    /// The title of the dialog in UTF-16\r
-    wchar_t *_title;\r
-    \r
-    /// The path of the currently selected file in UTF-16\r
-    wchar_t _path_string[_MAX_PATH];\r
-    \r
-    /// The filter string for GetOpenFileName in UTF-16\r
-    wchar_t *_filter;\r
-    \r
-    /// The index of the currently selected filter\r
-    int _filterIndex;\r
-    \r
-    /// An array of the extensions associated with the\r
-    /// file types of each filter. So the Nth entry of\r
-    /// this array corresponds to the extension of the Nth\r
-    /// filter in the list. NULL if no specific extension is\r
-    /// specified/\r
-    Inkscape::Extension::Extension **_extension_map;\r
-\r
-    /// The currently selected extension. Valid after an [OK]\r
-    Inkscape::Extension::Extension *_extension;\r
-};\r
-\r
-\r
-/*#########################################################################\r
-### F I L E    O P E N\r
-#########################################################################*/\r
-\r
-/// An Inkscape compatible wrapper around MS Windows GetOpenFileName API\r
-class FileOpenDialogImplWin32 : public FileOpenDialog, public FileDialogBaseWin32\r
-{\r
-public:\r
-    /// Constructor\r
-    /// @param parent The parent window for the dialog\r
-    /// @param dir The directory to begin browing from\r
-    /// @param title The title caption for the dialog in UTF-8\r
-    /// @param type The dialog type\r
-    FileOpenDialogImplWin32(Gtk::Window &parent, \r
-                       const Glib::ustring &dir,\r
-                       FileDialogType fileTypes,\r
-                       const char *title);\r
-\r
-    /// Destructor\r
-    virtual ~FileOpenDialogImplWin32();\r
-\r
-    /// Shows the file dialog, and blocks until a file\r
-    /// has been selected.\r
-    /// @return Returns true if the the user selected a\r
-    /// file, or false if the user pressed cancel.\r
-    bool show();\r
-\r
-    /// Gets a list of the selected file names\r
-    /// @return Returns an STL vector filled with the\r
-    /// GTK names of the selected files\r
-    std::vector<Glib::ustring> getFilenames();\r
-    \r
-    /// Get the path of the current directory\r
-    virtual Glib::ustring getCurrentDirectory()\r
-        { return FileDialogBaseWin32::getCurrentDirectory(); }\r
-\r
-    /// Gets the currently selected extension. Valid after an [OK]\r
-    /// @return Returns a pointer to the selected extension, or NULL\r
-    /// if the selected filter requires an automatic type detection\r
-    virtual Inkscape::Extension::Extension* getSelectionType()\r
-        { return FileDialogBaseWin32::getSelectionType(); }\r
-\r
-private:\r
-\r
-    /// Create a filter menu for this type of dialog\r
-    void createFilterMenu();\r
-    \r
-    /// The handle of the preview pane window\r
-    HWND _preview_wnd;\r
-    \r
-    /// The handle of the file dialog window\r
-    HWND _file_dialog_wnd;\r
-    \r
-    /// A pointer to the standard window proc of the\r
-    /// unhooked file dialog\r
-    WNDPROC _base_window_proc;\r
-    \r
-    /// The handle of the bitmap of the "show preview"\r
-    /// toggle button\r
-    HBITMAP _show_preview_button_bitmap;\r
-    \r
-    /// The handle of the toolbar's window\r
-    HWND _toolbar_wnd;\r
-    \r
-    /// This flag is set true when the preview should be\r
-    /// shown, or false when it should be hidden\r
-    static bool _show_preview;\r
-    \r
-    \r
-    /// The current width of the preview pane in pixels\r
-    int _preview_width;\r
-    \r
-    /// The current height of the preview pane in pixels\r
-    int _preview_height;\r
-    \r
-    /// The handle of the windows to display within the\r
-    /// preview pane, or NULL if no image should be displayed\r
-    HBITMAP _preview_bitmap;\r
-    \r
-    /// The windows shell icon for the selected file\r
-    HICON _preview_file_icon;\r
-    \r
-    /// The size of the preview file in kilobytes\r
-    unsigned long _preview_file_size;\r
-\r
-    \r
-    /// The width of the document to be shown in the preview panel\r
-    double _preview_document_width;\r
-    \r
-    /// The width of the document to be shown in the preview panel\r
-    double _preview_document_height;\r
-    \r
-    /// The width of the rendered preview image in pixels\r
-    int _preview_image_width;\r
-    \r
-    /// The height of the rendered preview image in pixels\r
-    int _preview_image_height;\r
-\r
-    /// A GDK Pixbuf of the rendered preview to be displayed\r
-    Glib::RefPtr<Gdk::Pixbuf> _preview_bitmap_image;\r
-    \r
-    /// This flag is set true if a file has been selected\r
-    bool _file_selected;\r
-    \r
-    \r
-    /// The controller function for the thread which calls\r
-    /// GetOpenFileName\r
-    void GetOpenFileName_thread();\r
-    \r
-    /// Registers the Windows Class of the preview panel window\r
-    static void register_preview_wnd_class();\r
-    \r
-    /// A message proc which is called by the standard dialog\r
-    /// proc\r
-    static UINT_PTR CALLBACK GetOpenFileName_hookproc(HWND hdlg, UINT uiMsg, WPARAM wParam, LPARAM lParam);\r
-    \r
-    /// A message proc which wraps the standard dialog proc,\r
-    /// but intercepts some calls\r
-    static LRESULT CALLBACK file_dialog_subclass_proc(HWND hwnd, UINT uMsg, WPARAM wParam, LPARAM lParam);\r
-    \r
-    /// The message proc for the preview panel window\r
-    static LRESULT CALLBACK preview_wnd_proc(HWND hwnd, UINT uMsg, WPARAM wParam, LPARAM lParam);\r
-    \r
-    /// Lays out the controls in the file dialog given it's\r
-    /// current size\r
-    /// GetOpenFileName thread only.\r
-    void layout_dialog();\r
-    \r
-    /// Enables or disables the file preview.\r
-    /// GetOpenFileName thread only.\r
-    void enable_preview(bool enable);\r
-    \r
-    /// This function is called in the App thread when a file had\r
-    /// been selected\r
-    void file_selected();\r
-    \r
-    /// Loads and renders the unshrunk preview image.\r
-    /// Main app thread only.\r
-    void load_preview();\r
-    \r
-    /// Frees all the allocated objects associated with the file\r
-    /// currently being previewed\r
-    /// Main app thread only.\r
-    void free_preview();\r
-    \r
-    /// Loads preview for an SVG or SVGZ file.\r
-    /// Main app thread only.\r
-    /// @return Returns true if the SVG loaded successfully\r
-    bool set_svg_preview();\r
-    \r
-    /// A callback to allow this class to dispose of the\r
-    /// memory block of the rendered SVG bitmap\r
-    /// @buffer buffer The buffer to free\r
-    static void destroy_svg_rendering(const guint8 *buffer);\r
-    \r
-    /// Loads the preview for a raster image\r
-    /// Main app thread only.\r
-    /// @return Returns true if the image loaded successfully\r
-    bool set_image_preview();\r
-    \r
-    /// Renders the unshrunk preview image to a windows HTBITMAP\r
-    /// which can be painted in the preview pain.\r
-    /// Main app thread only.\r
-    void render_preview();\r
-    \r
-    /// Formats the caption in UTF-16 for the preview image\r
-    /// @param caption The buffer to format the caption string into\r
-    /// @param caption_size The number of wchar_ts in the caption buffer \r
-    /// @return Returns the number of characters in caption string\r
-    int format_caption(wchar_t *caption, int caption_size);\r
-};\r
-\r
-\r
-/*#########################################################################\r
-### F I L E    S A V E\r
-#########################################################################*/\r
-\r
-/// An Inkscape compatible wrapper around MS Windows GetSaveFileName API\r
-class FileSaveDialogImplWin32 : public FileSaveDialog, public FileDialogBaseWin32\r
-{\r
-\r
-public:\r
-    FileSaveDialogImplWin32(Gtk::Window &parent, \r
-                       const Glib::ustring &dir,\r
-                       FileDialogType fileTypes,\r
-                       const char *title,\r
-                       const Glib::ustring &default_key);\r
-\r
-    /// Destructor\r
-    virtual ~FileSaveDialogImplWin32();\r
-\r
-    /// Shows the file dialog, and blocks until a file\r
-    /// has been selected.\r
-    /// @return Returns true if the the user selected a\r
-    /// file, or false if the user pressed cancel.\r
-    bool show();\r
-    \r
-    /// Get the path of the current directory\r
-    virtual Glib::ustring getCurrentDirectory()\r
-        { return FileDialogBaseWin32::getCurrentDirectory(); }\r
-\r
-    /// Gets the currently selected extension. Valid after an [OK]\r
-    /// @return Returns a pointer to the selected extension, or NULL\r
-    /// if the selected filter requires an automatic type detection\r
-    virtual Inkscape::Extension::Extension* getSelectionType()\r
-        { return FileDialogBaseWin32::getSelectionType(); }\r
-\r
-    virtual void setSelectionType( Inkscape::Extension::Extension *key );\r
-    \r
-private:\r
-\r
-    /**\r
-     *  Create a filter menu for this type of dialog\r
-     */\r
-    void createFilterMenu();\r
-\r
-    void GetSaveFileName_thread();\r
-};\r
-\r
-\r
-}\r
-}\r
-}\r
-\r
-#endif\r
-\r
-/*\r
-  Local Variables:\r
-  mode:c++\r
-  c-file-style:"stroustrup"\r
-  c-file-offsets:((innamespace . 0)(inline-open . 0)(case-label . +))\r
-  indent-tabs-mode:nil\r
-  fill-column:99\r
-  End:\r
-*/\r
-// vim: filetype=cpp:expandtab:shiftwidth=4:tabstop=8:softtabstop=4 :\r
+/**
+ * Implementation of the file dialog interfaces defined in filedialog.h for Win32
+ *
+ * Authors:
+ *   Joel Holdsworth
+ *   The Inkscape Organization
+ *
+ * Copyright (C) 2004-2008 The Inkscape Organization
+ *
+ * Released under GNU GPL, read the file 'COPYING' for more information
+ */
+
+#ifdef WIN32
+
+#include "gc-core.h"
+#include <windows.h>
+
+namespace Inkscape
+{
+namespace UI
+{
+namespace Dialog
+{
+
+/*#########################################################################
+### F I L E     D I A L O G    B A S E    C L A S S
+#########################################################################*/
+
+/// This class is the base implementation of a MS Windows
+/// file dialog.
+class FileDialogBaseWin32
+{
+protected:
+    /// Abstract Constructor
+    /// @param parent The parent window for the dialog
+    /// @param dir The directory to begin browing from
+    /// @param title The title caption for the dialog in UTF-8
+    /// @param type The dialog type
+    /// @param preferenceBase The preferences key
+    FileDialogBaseWin32(Gtk::Window &parent, const Glib::ustring &dir,
+        const char *title, FileDialogType type,
+        gchar const *preferenceBase);
+
+    /// Destructor
+    ~FileDialogBaseWin32();
+
+public:
+
+    /// Gets the currently selected extension. Valid after an [OK]
+    /// @return Returns a pointer to the selected extension, or NULL
+    /// if the selected filter requires an automatic type detection
+    Inkscape::Extension::Extension* getSelectionType();
+
+    /// Get the path of the current directory
+    Glib::ustring getCurrentDirectory();
+
+protected:
+    /// The dialog type
+    FileDialogType dialogType;
+
+    /// This mutex is used to ensure that the worker thread
+    /// that calls GetOpenFileName cannot collide with the
+    /// main Inkscape thread
+    Glib::Mutex *_mutex;
+
+    /// This flag is set true when the GetOpenFileName call
+    /// has returned
+    bool _finished;
+
+    /// A pointer to the GTK main-loop context object. This
+    /// is used to keep the rest of the inkscape UI running
+    /// while the file dialog is displayed
+    GMainLoop *_main_loop;
+
+    /// The result of the call to GetOpenFileName. If true
+    /// the user clicked OK, if false the user clicked cancel
+    bool _result;
+
+    /// The parent window
+    Gtk::Window &parent;
+
+    /// The windows handle of the parent window
+    HWND _ownerHwnd;
+
+    /// The path of the directory that is currently being
+    /// browsed
+    Glib::ustring _current_directory;
+
+    /// The title of the dialog in UTF-16
+    wchar_t *_title;
+
+    /// The path of the currently selected file in UTF-16
+    wchar_t _path_string[_MAX_PATH];
+
+    /// The filter string for GetOpenFileName in UTF-16
+    wchar_t *_filter;
+
+    /// The index of the currently selected filter
+    int _filterIndex;
+
+    /// An array of the extensions associated with the
+    /// file types of each filter. So the Nth entry of
+    /// this array corresponds to the extension of the Nth
+    /// filter in the list. NULL if no specific extension is
+    /// specified/
+    Inkscape::Extension::Extension **_extension_map;
+
+    /// The currently selected extension. Valid after an [OK]
+    Inkscape::Extension::Extension *_extension;
+};
+
+
+/*#########################################################################
+### F I L E    O P E N
+#########################################################################*/
+
+/// An Inkscape compatible wrapper around MS Windows GetOpenFileName API
+class FileOpenDialogImplWin32 : public FileOpenDialog, public FileDialogBaseWin32
+{
+public:
+    /// Constructor
+    /// @param parent The parent window for the dialog
+    /// @param dir The directory to begin browing from
+    /// @param title The title caption for the dialog in UTF-8
+    /// @param type The dialog type
+    FileOpenDialogImplWin32(Gtk::Window &parent,
+                       const Glib::ustring &dir,
+                       FileDialogType fileTypes,
+                       const char *title);
+
+    /// Destructor
+    virtual ~FileOpenDialogImplWin32();
+
+    /// Shows the file dialog, and blocks until a file
+    /// has been selected.
+    /// @return Returns true if the the user selected a
+    /// file, or false if the user pressed cancel.
+    bool show();
+
+    /// Gets a list of the selected file names
+    /// @return Returns an STL vector filled with the
+    /// GTK names of the selected files
+    std::vector<Glib::ustring> getFilenames();
+
+    /// Get the path of the current directory
+    virtual Glib::ustring getCurrentDirectory()
+        { return FileDialogBaseWin32::getCurrentDirectory(); }
+
+    /// Gets the currently selected extension. Valid after an [OK]
+    /// @return Returns a pointer to the selected extension, or NULL
+    /// if the selected filter requires an automatic type detection
+    virtual Inkscape::Extension::Extension* getSelectionType()
+        { return FileDialogBaseWin32::getSelectionType(); }
+
+private:
+
+    /// Create a filter menu for this type of dialog
+    void createFilterMenu();
+
+    /// The handle of the preview pane window
+    HWND _preview_wnd;
+
+    /// The handle of the file dialog window
+    HWND _file_dialog_wnd;
+
+    /// A pointer to the standard window proc of the
+    /// unhooked file dialog
+    WNDPROC _base_window_proc;
+
+    /// The handle of the bitmap of the "show preview"
+    /// toggle button
+    HBITMAP _show_preview_button_bitmap;
+
+    /// The handle of the toolbar's window
+    HWND _toolbar_wnd;
+
+    /// This flag is set true when the preview should be
+    /// shown, or false when it should be hidden
+    static bool _show_preview;
+
+
+    /// The current width of the preview pane in pixels
+    int _preview_width;
+
+    /// The current height of the preview pane in pixels
+    int _preview_height;
+
+    /// The handle of the windows to display within the
+    /// preview pane, or NULL if no image should be displayed
+    HBITMAP _preview_bitmap;
+
+    /// The windows shell icon for the selected file
+    HICON _preview_file_icon;
+
+    /// The size of the preview file in kilobytes
+    unsigned long _preview_file_size;
+
+
+    /// The width of the document to be shown in the preview panel
+    double _preview_document_width;
+
+    /// The width of the document to be shown in the preview panel
+    double _preview_document_height;
+
+    /// The width of the rendered preview image in pixels
+    int _preview_image_width;
+
+    /// The height of the rendered preview image in pixels
+    int _preview_image_height;
+
+    /// A GDK Pixbuf of the rendered preview to be displayed
+    Glib::RefPtr<Gdk::Pixbuf> _preview_bitmap_image;
+
+    /// This flag is set true if a file has been selected
+    bool _file_selected;
+
+
+    /// The controller function for the thread which calls
+    /// GetOpenFileName
+    void GetOpenFileName_thread();
+
+    /// Registers the Windows Class of the preview panel window
+    static void register_preview_wnd_class();
+
+    /// A message proc which is called by the standard dialog
+    /// proc
+    static UINT_PTR CALLBACK GetOpenFileName_hookproc(HWND hdlg, UINT uiMsg, WPARAM wParam, LPARAM lParam);
+
+    /// A message proc which wraps the standard dialog proc,
+    /// but intercepts some calls
+    static LRESULT CALLBACK file_dialog_subclass_proc(HWND hwnd, UINT uMsg, WPARAM wParam, LPARAM lParam);
+
+    /// The message proc for the preview panel window
+    static LRESULT CALLBACK preview_wnd_proc(HWND hwnd, UINT uMsg, WPARAM wParam, LPARAM lParam);
+
+    /// Lays out the controls in the file dialog given it's
+    /// current size
+    /// GetOpenFileName thread only.
+    void layout_dialog();
+
+    /// Enables or disables the file preview.
+    /// GetOpenFileName thread only.
+    void enable_preview(bool enable);
+
+    /// This function is called in the App thread when a file had
+    /// been selected
+    void file_selected();
+
+    /// Loads and renders the unshrunk preview image.
+    /// Main app thread only.
+    void load_preview();
+
+    /// Frees all the allocated objects associated with the file
+    /// currently being previewed
+    /// Main app thread only.
+    void free_preview();
+
+    /// Loads preview for an SVG or SVGZ file.
+    /// Main app thread only.
+    /// @return Returns true if the SVG loaded successfully
+    bool set_svg_preview();
+
+    /// A callback to allow this class to dispose of the
+    /// memory block of the rendered SVG bitmap
+    /// @buffer buffer The buffer to free
+    static void destroy_svg_rendering(const guint8 *buffer);
+
+    /// Loads the preview for a raster image
+    /// Main app thread only.
+    /// @return Returns true if the image loaded successfully
+    bool set_image_preview();
+
+    /// Renders the unshrunk preview image to a windows HTBITMAP
+    /// which can be painted in the preview pain.
+    /// Main app thread only.
+    void render_preview();
+
+    /// Formats the caption in UTF-16 for the preview image
+    /// @param caption The buffer to format the caption string into
+    /// @param caption_size The number of wchar_ts in the caption buffer
+    /// @return Returns the number of characters in caption string
+    int format_caption(wchar_t *caption, int caption_size);
+};
+
+
+/*#########################################################################
+### F I L E    S A V E
+#########################################################################*/
+
+/// An Inkscape compatible wrapper around MS Windows GetSaveFileName API
+class FileSaveDialogImplWin32 : public FileSaveDialog, public FileDialogBaseWin32
+{
+
+public:
+    FileSaveDialogImplWin32(Gtk::Window &parent,
+                       const Glib::ustring &dir,
+                       FileDialogType fileTypes,
+                       const char *title,
+                       const Glib::ustring &default_key);
+
+    /// Destructor
+    virtual ~FileSaveDialogImplWin32();
+
+    /// Shows the file dialog, and blocks until a file
+    /// has been selected.
+    /// @return Returns true if the the user selected a
+    /// file, or false if the user pressed cancel.
+    bool show();
+
+    /// Get the path of the current directory
+    virtual Glib::ustring getCurrentDirectory()
+        { return FileDialogBaseWin32::getCurrentDirectory(); }
+
+    /// Gets the currently selected extension. Valid after an [OK]
+    /// @return Returns a pointer to the selected extension, or NULL
+    /// if the selected filter requires an automatic type detection
+    virtual Inkscape::Extension::Extension* getSelectionType()
+        { return FileDialogBaseWin32::getSelectionType(); }
+
+    virtual void setSelectionType( Inkscape::Extension::Extension *key );
+
+private:
+
+    /**
+     *  Create a filter menu for this type of dialog
+     */
+    void createFilterMenu();
+
+    void GetSaveFileName_thread();
+};
+
+
+}
+}
+}
+
+#endif
+
+/*
+  Local Variables:
+  mode:c++
+  c-file-style:"stroustrup"
+  c-file-offsets:((innamespace . 0)(inline-open . 0)(case-label . +))
+  indent-tabs-mode:nil
+  fill-column:99
+  End:
+*/
+// vim: filetype=cpp:expandtab:shiftwidth=4:tabstop=8:softtabstop=4 :