aboutsummaryrefslogtreecommitdiff
diff options
context:
space:
mode:
-rwxr-xr-xnad/testvarious26
-rw-r--r--nad/tv_out.dist14
-rw-r--r--src/Makefile.am4
-rw-r--r--src/PJ_sch.c228
-rw-r--r--src/lib_proj.cmake3
-rw-r--r--src/makefile.vc7
-rw-r--r--src/pj_fwd.c19
-rw-r--r--src/pj_fwd3d.c47
-rw-r--r--src/pj_inv.c17
-rw-r--r--src/pj_inv3d.c45
-rw-r--r--src/pj_list.h2
-rw-r--r--src/pj_transform.c181
-rw-r--r--src/proj.def2
-rw-r--r--src/proj_api.h8
-rw-r--r--src/projects.h12
-rw-r--r--wince/msvc80/projce_dll/projce_dll.vcproj1130
-rw-r--r--wince/msvc80/projce_lib/projce_lib.vcproj1098
17 files changed, 1111 insertions, 1732 deletions
diff --git a/nad/testvarious b/nad/testvarious
index 0ea4c133..3cb29d92 100755
--- a/nad/testvarious
+++ b/nad/testvarious
@@ -687,6 +687,32 @@ $EXE -f '%.7f' \
-E >>${OUT} <<EOF
10 34
EOF
+echo "##############################################################" >> ${OUT}
+echo "Test SCH forward projection" >> ${OUT}
+#
+$EXE -f '%.7f' \
+ +proj=latlong +datum=WGS84 +to +proj=sch +datum=WGS84 +plat_0=30.0 +plon_0=45.0 \
+ +phdg_0=-12.0 +nodefs \
+ -E >> ${OUT} <<EOF
+0.0 0.0
+0.0 90.0
+45.0 45.0
+45.1 44.9
+44.9 45.1
+30.0 45.0
+EOF
+echo "##############################################################" >> ${OUT}
+echo "Test SCH inverse projection" >> ${OUT}
+#
+$EXE -f '%.7f' \
+ +proj=sch +datum=WGS84 +plat_0=30.0 +plon_0=45.0 +phdg_0=-12.0 +nodefs +to \
+ +proj=latlong +datum=WGS84 \
+ -E >> ${OUT} <<EOF
+0. 0.
+0. 1000.
+1000. 0.
+1000. 1000.
+EOF
##############################################################################
echo "##############################################################" >> ${OUT}
echo "Test issue #316 (switch utm to use etmerc)" >> ${OUT}
diff --git a/nad/tv_out.dist b/nad/tv_out.dist
index 00063c47..3b16b624 100644
--- a/nad/tv_out.dist
+++ b/nad/tv_out.dist
@@ -318,6 +318,20 @@ Test bug 245 (use +datum=carthage)
Test bug 245 (use expansion of +datum=carthage)
10 34 592302.9819461 3762148.7340609 -30.3110170
##############################################################
+Test SCH forward projection
+0.0 0.0 -1977112.0305592 5551475.1418378 6595.7256583
+0.0 90.0 -4303095.6927530 -4253039.2182667 6595.7256583
+45.0 45.0 1630035.5650122 -342353.6396475 128.3445654
+45.1 44.9 1642526.7453121 -336878.8571851 131.3265616
+44.9 45.1 1617547.4295637 -347855.9734973 125.4645102
+30.0 45.0 0.0000000 0.0000000 0.0000000
+##############################################################
+Test SCH inverse projection
+0. 0. 30.0000000 45.0000000 0.0000000
+0. 1000. 29.9981240 44.9898625 -0.0003617
+1000. 0. 30.0088238 44.9978450 -0.0000000
+1000. 1000. 30.0069477 44.9877066 -0.0005228
+##############################################################
Test issue #316 (switch utm to use etmerc)
0 83 145723.870553 9300924.845226 0.000000
##############################################################
diff --git a/src/Makefile.am b/src/Makefile.am
index 5d89cc28..83c5f34e 100644
--- a/src/Makefile.am
+++ b/src/Makefile.am
@@ -54,12 +54,12 @@ libproj_la_SOURCES = \
PJ_mbt_fps.c PJ_mbtfpp.c PJ_mbtfpq.c PJ_moll.c \
PJ_nell.c PJ_nell_h.c PJ_putp2.c PJ_putp3.c \
PJ_putp4p.c PJ_putp5.c PJ_putp6.c PJ_qsc.c PJ_robin.c \
- PJ_sts.c PJ_urm5.c PJ_urmfps.c PJ_wag2.c \
+ PJ_sch.c PJ_sts.c PJ_urm5.c PJ_urmfps.c PJ_wag2.c \
PJ_wag3.c PJ_wink1.c PJ_wink2.c pj_latlong.c pj_geocent.c \
aasincos.c adjlon.c bch2bps.c bchgen.c \
biveval.c dmstor.c mk_cheby.c pj_auth.c \
pj_deriv.c pj_ell_set.c pj_ellps.c pj_errno.c \
- pj_factors.c pj_fwd.c pj_init.c pj_inv.c \
+ pj_factors.c pj_fwd.c pj_init.c pj_inv.c pj_fwd3d.c pj_inv3d.c\
pj_list.c pj_malloc.c pj_mlfn.c pj_msfn.c proj_mdist.c \
pj_open_lib.c pj_param.c pj_phi2.c pj_pr_list.c \
pj_qsfn.c pj_strerrno.c pj_tsfn.c pj_units.c pj_ctx.c pj_log.c \
diff --git a/src/PJ_sch.c b/src/PJ_sch.c
new file mode 100644
index 00000000..5571deb3
--- /dev/null
+++ b/src/PJ_sch.c
@@ -0,0 +1,228 @@
+/******************************************************************************
+ * $Id$
+ *
+ * Project: SCH Coordinate system
+ * Purpose: Implementation of SCH Coordinate system
+ * References :
+ * 1. Hensley. Scott. SCH Coordinates and various transformations. June 15, 2000.
+ * 2. Buckley, Sean Monroe. Radar interferometry measurement of land subsidence. 2000..
+ * PhD Thesis. UT Austin. (Appendix)
+ * 3. Hensley, Scott, Elaine Chapin, and T. Michel. "Improved processing of AIRSAR
+ * data based on the GeoSAR processor." Airsar earth science and applications
+ * workshop, March. 2002. (http://airsar.jpl.nasa.gov/documents/workshop2002/papers/T3.pdf)
+ *
+ * Author: Piyush Agram (piyush.agram@jpl.nasa.gov)
+ * Copyright (c) 2015 California Institute of Technology.
+ * Government sponsorship acknowledged.
+ *
+ * NOTE: The SCH coordinate system is a sensor aligned coordinate system
+ * developed at JPL for radar mapping missions. Details pertaining to the
+ * coordinate system have been release in the public domain (see references above).
+ * This code is an independent implementation of the SCH coordinate system
+ * that conforms to the PROJ.4 conventions and uses the details presented in these
+ * publicly released documents. All credit for the development of the coordinate
+ * system and its use should be directed towards the original developers at JPL.
+ ******************************************************************************
+ * THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS
+ * OR IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY,
+ * FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL
+ * THE AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER
+ * LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING
+ * FROM, OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER
+ * DEALINGS IN THE SOFTWARE.
+ ****************************************************************************/
+
+#include "geocent.h"
+
+#define PROJ_PARMS__ \
+ double plat; /*Peg Latitude */ \
+ double plon; /*Peg Longitude*/ \
+ double phdg; /*Peg heading */ \
+ double h0; /*Average altitude */\
+ double transMat[9]; \
+ double xyzoff[3]; \
+ double rcurv; \
+ GeocentricInfo sph; \
+ GeocentricInfo elp_0;
+
+#define PJ_LIB__
+#include <projects.h>
+
+PROJ_HEAD(sch, "Spherical Cross-track Height") "\n\tMisc\n\tplat_0 = ,plon_0 = , phdg_0 = ,[h_0 = ]";
+
+INVERSE3D(inverse3d);
+ double temp[3];
+ double pxyz[3];
+
+ //Local lat,lon using radius
+ pxyz[0] = xyz.y * P->a / P->rcurv;
+ pxyz[1] = xyz.x * P->a / P->rcurv;
+ pxyz[2] = xyz.z;
+
+
+ if( pj_Convert_Geodetic_To_Geocentric( &(P->sph), pxyz[0], pxyz[1], pxyz[2],
+ temp, temp+1, temp+2) != 0)
+ I3_ERROR;
+
+ //Apply rotation
+ pxyz[0] = P->transMat[0] * temp[0] + P->transMat[1] * temp[1] + P->transMat[2] * temp[2];
+ pxyz[1] = P->transMat[3] * temp[0] + P->transMat[4] * temp[1] + P->transMat[5] * temp[2];
+ pxyz[2] = P->transMat[6] * temp[0] + P->transMat[7] * temp[1] + P->transMat[8] * temp[2];
+
+ //Apply offset
+ pxyz[0] += P->xyzoff[0];
+ pxyz[1] += P->xyzoff[1];
+ pxyz[2] += P->xyzoff[2];
+
+ //Convert geocentric coordinates to lat lon
+ pj_Convert_Geocentric_To_Geodetic( &(P->elp_0), pxyz[0], pxyz[1], pxyz[2],
+ temp, temp+1, temp+2);
+
+
+ lpz.lam = temp[0] ;
+ lpz.phi = temp[1] ;
+ lpz.z = temp[2];
+
+// printf("INVERSE: \n");
+// printf("XYZ: %f %f %f \n", xyz.x, xyz.y, xyz.z);
+// printf("LPZ: %f %f %f \n", lpz.lam, lpz.phi, lpz.z);
+ return (lpz);
+}
+
+FORWARD3D(forward3d);
+ double temp[3];
+ double pxyz[3];
+
+ //Convert lat lon to geocentric coordinates
+ if( pj_Convert_Geodetic_To_Geocentric( &(P->elp_0), lpz.lam, lpz.phi, lpz.z,
+ temp, temp+1, temp+2 ) != 0 )
+ F3_ERROR;
+
+ //Adjust for offset
+ temp[0] -= P->xyzoff[0];
+ temp[1] -= P->xyzoff[1];
+ temp[2] -= P->xyzoff[2];
+
+
+ //Apply rotation
+ pxyz[0] = P->transMat[0] * temp[0] + P->transMat[3] * temp[1] + P->transMat[6] * temp[2];
+ pxyz[1] = P->transMat[1] * temp[0] + P->transMat[4] * temp[1] + P->transMat[7] * temp[2];
+ pxyz[2] = P->transMat[2] * temp[0] + P->transMat[5] * temp[1] + P->transMat[8] * temp[2];
+
+ //Convert to local lat,lon
+ pj_Convert_Geocentric_To_Geodetic( &(P->sph), pxyz[0], pxyz[1], pxyz[2],
+ temp, temp+1, temp+2);
+
+ //Scale by radius
+ xyz.x = temp[1] * P->rcurv / P->a;
+ xyz.y = temp[0] * P->rcurv / P->a;
+ xyz.z = temp[2];
+
+// printf("FORWARD: \n");
+// printf("LPZ: %f %f %f \n", lpz.lam, lpz.phi, lpz.z);
+// printf("XYZ: %f %f %f \n", xyz.x, xyz.y, xyz.z);
+
+ return (xyz);
+}
+
+FREEUP; if (P) pj_dalloc(P); }
+ static PJ *
+setup(PJ *P) { /* general initialization */
+ double reast, rnorth;
+ double chdg, shdg;
+ double clt, slt;
+ double clo, slo;
+ double temp;
+ double pxyz[3];
+
+ temp = P->a * sqrt(1.0 - P->es);
+
+ //Setup original geocentric system
+ if ( pj_Set_Geocentric_Parameters(&(P->elp_0), P->a, temp) != 0)
+ E_ERROR(-37);
+
+
+ clt = cos(P->plat);
+ slt = sin(P->plat);
+ clo = cos(P->plon);
+ slo = sin(P->plon);
+
+ //Estimate the radius of curvature for given peg
+ temp = sqrt(1.0 - (P->es) * slt * slt);
+ reast = (P->a)/temp;
+ rnorth = (P->a) * (1.0 - (P->es))/pow(temp,3);
+
+ chdg = cos(P->phdg);
+ shdg = sin(P->phdg);
+
+ P->rcurv = P->h0 + (reast*rnorth)/(reast * chdg * chdg + rnorth * shdg * shdg);
+
+// printf("North Radius: %f \n", rnorth);
+// printf("East Radius: %f \n", reast);
+// printf("Effective Radius: %f \n", P->rcurv);
+
+ //Set up local sphere at the given peg point
+ if ( pj_Set_Geocentric_Parameters(&(P->sph), P->rcurv, P->rcurv) != 0)
+ E_ERROR(-37);
+
+ //Set up the transformation matrices
+ P->transMat[0] = clt * clo;
+ P->transMat[1] = -shdg*slo - slt*clo * chdg;
+ P->transMat[2] = slo*chdg - slt*clo*shdg;
+ P->transMat[3] = clt*slo;
+ P->transMat[4] = clo*shdg - slt*slo*chdg;
+ P->transMat[5] = -clo*chdg - slt*slo*shdg;
+ P->transMat[6] = slt;
+ P->transMat[7] = clt*chdg;
+ P->transMat[8] = clt*shdg;
+
+
+ if( pj_Convert_Geodetic_To_Geocentric( &(P->elp_0), P->plat, P->plon, P->h0,
+ pxyz, pxyz+1, pxyz+2 ) != 0 )
+ {
+ E_ERROR(-14)
+ }
+
+
+ P->xyzoff[0] = pxyz[0] - (P->rcurv) * clt * clo;
+ P->xyzoff[1] = pxyz[1] - (P->rcurv) * clt * slo;
+ P->xyzoff[2] = pxyz[2] - (P->rcurv) * slt;
+
+// printf("Offset: %f %f %f \n", P->xyzoff[0], P->xyzoff[1], P->xyzoff[2]);
+
+
+ P->fwd3d = forward3d;
+ P->inv3d = inverse3d;
+ return P;
+}
+ENTRY0(sch)
+ P->h0 = 0.0;
+
+ //Check if peg latitude was defined
+ if (pj_param(P->ctx, P->params, "tplat_0").i)
+ P->plat = pj_param(P->ctx, P->params, "rplat_0").f;
+ else
+ E_ERROR(-37);
+
+ //Check if peg longitude was defined
+ if (pj_param(P->ctx, P->params, "tplon_0").i)
+ P->plon = pj_param(P->ctx, P->params, "rplon_0").f;
+ else
+ E_ERROR(-37);
+
+ //Check if peg latitude is defined
+ if (pj_param(P->ctx, P->params, "tphdg_0").i)
+ P->phdg = pj_param(P->ctx, P->params, "rphdg_0").f;
+ else
+ E_ERROR(-37);
+
+
+ //Check if average height was defined
+ //If so read it in
+ if (pj_param(P->ctx, P->params, "th_0").i)
+ P->h0 = pj_param(P->ctx, P->params, "dh_0").f;
+
+ //Completed reading in the projection parameters
+// printf("PSA: Lat = %f Lon = %f Hdg = %f \n", P->plat, P->plon, P->phdg);
+
+ENDENTRY(setup(P))
diff --git a/src/lib_proj.cmake b/src/lib_proj.cmake
index 8a6349d8..b7b497cc 100644
--- a/src/lib_proj.cmake
+++ b/src/lib_proj.cmake
@@ -115,6 +115,7 @@ SET(SRC_LIBPROJ_PJ
PJ_qsc.c
PJ_robin.c
PJ_rpoly.c
+ PJ_sch.c
PJ_sconics.c
PJ_somerc.c
PJ_sterea.c
@@ -166,6 +167,7 @@ SET(SRC_LIBPROJ_CORE
pj_errno.c
pj_factors.c
pj_fwd.c
+ pj_fwd3d.c
pj_gauss.c
pj_gc_reader.c
pj_geocent.c
@@ -176,6 +178,7 @@ SET(SRC_LIBPROJ_CORE
pj_init.c
pj_initcache.c
pj_inv.c
+ pj_inv3d.c
pj_latlong.c
pj_list.c
pj_list.h
diff --git a/src/makefile.vc b/src/makefile.vc
index 41b7dca8..ed7ab4c4 100644
--- a/src/makefile.vc
+++ b/src/makefile.vc
@@ -24,9 +24,9 @@ misc = \
PJ_airy.obj PJ_aitoff.obj PJ_august.obj PJ_bacon.obj \
PJ_chamb.obj PJ_hammer.obj PJ_lagrng.obj PJ_larr.obj \
PJ_lask.obj PJ_nocol.obj PJ_ob_tran.obj PJ_oea.obj \
- PJ_tpeqd.obj PJ_vandg.obj PJ_vandg2.obj PJ_vandg4.obj \
- PJ_wag7.obj pj_latlong.obj PJ_krovak.obj pj_geocent.obj \
- PJ_healpix.obj PJ_natearth.obj PJ_qsc.obj
+ PJ_sch.obj PJ_tpeqd.obj PJ_vandg.obj PJ_vandg2.obj \
+ PJ_vandg4.obj PJ_wag7.obj pj_latlong.obj PJ_krovak.obj \
+ pj_geocent.obj PJ_healpix.obj PJ_natearth.obj PJ_qsc.obj
pseudo = \
PJ_boggs.obj PJ_collg.obj PJ_crast.obj PJ_denoy.obj \
@@ -45,6 +45,7 @@ support = \
biveval.obj dmstor.obj mk_cheby.obj pj_auth.obj \
pj_deriv.obj pj_ell_set.obj pj_ellps.obj pj_errno.obj \
pj_factors.obj pj_fwd.obj pj_init.obj pj_inv.obj \
+ pj_fwd3d.obj pj_inv3d.obj \
pj_list.obj pj_malloc.obj pj_mlfn.obj pj_msfn.obj \
pj_open_lib.obj pj_param.obj pj_phi2.obj pj_pr_list.obj \
pj_qsfn.obj pj_strerrno.obj pj_tsfn.obj pj_units.obj \
diff --git a/src/pj_fwd.c b/src/pj_fwd.c
index b70b4240..1cd002b5 100644
--- a/src/pj_fwd.c
+++ b/src/pj_fwd.c
@@ -24,14 +24,23 @@ pj_fwd(LP lp, PJ *P) {
lp.lam -= P->lam0; /* compute del lp.lam */
if (!P->over)
lp.lam = adjlon(lp.lam); /* adjust del longitude */
- xy = (*P->fwd)(lp, P); /* project */
- if ( P->ctx->last_errno )
+
+ //Check for NULL pointer
+ if (P->fwd != NULL)
+ {
+ xy = (*P->fwd)(lp, P); /* project */
+ if ( P->ctx->last_errno )
xy.x = xy.y = HUGE_VAL;
- /* adjust for major axis and easting/northings */
- else {
+ /* adjust for major axis and easting/northings */
+ else {
xy.x = P->fr_meter * (P->a * xy.x + P->x0);
xy.y = P->fr_meter * (P->a * xy.y + P->y0);
- }
+ }
+ }
+ else
+ {
+ xy.x = xy.y = HUGE_VAL;
+ }
}
return xy;
}
diff --git a/src/pj_fwd3d.c b/src/pj_fwd3d.c
new file mode 100644
index 00000000..834746d4
--- /dev/null
+++ b/src/pj_fwd3d.c
@@ -0,0 +1,47 @@
+/* general forward projection */
+#define PJ_LIB__
+#include <projects.h>
+#include <errno.h>
+# define EPS 1.0e-12
+ XYZ /* forward projection entry */
+pj_fwd3d(LPZ lpz, PJ *P) {
+ XYZ xyz;
+ double t;
+
+ /* check for forward and latitude or longitude overange */
+ if ((t = fabs(lpz.phi)-HALFPI) > EPS || fabs(lpz.lam) > 10.) {
+ xyz.x = xyz.y = xyz.z = HUGE_VAL;
+ pj_ctx_set_errno( P->ctx, -14);
+ } else { /* proceed with projection */
+ P->ctx->last_errno = 0;
+ pj_errno = 0;
+ errno = 0;
+
+ if (fabs(t) <= EPS)
+ lpz.phi = lpz.phi < 0. ? -HALFPI : HALFPI;
+ else if (P->geoc) //Maybe redundant and never used.
+ lpz.phi = atan(P->rone_es * tan(lpz.phi));
+ lpz.lam -= P->lam0; /* compute del lp.lam */
+ if (!P->over)
+ lpz.lam = adjlon(lpz.lam); /* adjust del longitude */
+
+ //Check for NULL pointer
+ if (P->fwd3d != NULL)
+ {
+ xyz = (*P->fwd3d)(lpz, P); /* project */
+ if ( P->ctx->last_errno )
+ xyz.x = xyz.y = xyz.z = HUGE_VAL;
+ /* adjust for major axis and easting/northings */
+ else {
+ xyz.x = P->fr_meter * (P->a * xyz.x + P->x0);
+ xyz.y = P->fr_meter * (P->a * xyz.y + P->y0);
+ //z is not scaled since this handled by vto_meter outside
+ }
+ }
+ else
+ {
+ xyz.x = xyz.y = xyz.z = HUGE_VAL;
+ }
+ }
+ return xyz;
+}
diff --git a/src/pj_inv.c b/src/pj_inv.c
index a418ccd4..d77b4e56 100644
--- a/src/pj_inv.c
+++ b/src/pj_inv.c
@@ -19,15 +19,24 @@ pj_inv(XY xy, PJ *P) {
xy.x = (xy.x * P->to_meter - P->x0) * P->ra; /* descale and de-offset */
xy.y = (xy.y * P->to_meter - P->y0) * P->ra;
- lp = (*P->inv)(xy, P); /* inverse project */
- if (P->ctx->last_errno )
+
+ //Check for NULL pointer
+ if (P->inv != NULL)
+ {
+ lp = (*P->inv)(xy, P); /* inverse project */
+ if (P->ctx->last_errno )
lp.lam = lp.phi = HUGE_VAL;
- else {
+ else {
lp.lam += P->lam0; /* reduce from del lp.lam */
if (!P->over)
lp.lam = adjlon(lp.lam); /* adjust longitude to CM */
if (P->geoc && fabs(fabs(lp.phi)-HALFPI) > EPS)
lp.phi = atan(P->one_es * tan(lp.phi));
- }
+ }
+ }
+ else
+ {
+ lp.lam = lp.phi = HUGE_VAL;
+ }
return lp;
}
diff --git a/src/pj_inv3d.c b/src/pj_inv3d.c
new file mode 100644
index 00000000..de35e776
--- /dev/null
+++ b/src/pj_inv3d.c
@@ -0,0 +1,45 @@
+/* general inverse projection */
+#define PJ_LIB__
+#include <projects.h>
+#include <errno.h>
+# define EPS 1.0e-12
+ LPZ /* inverse projection entry */
+pj_inv3d(XYZ xyz, PJ *P) {
+ LPZ lpz;
+
+ /* can't do as much preliminary checking as with forward */
+ if (xyz.x == HUGE_VAL || xyz.y == HUGE_VAL || xyz.z == HUGE_VAL ) {
+ lpz.lam = lpz.phi = lpz.z = HUGE_VAL;
+ pj_ctx_set_errno( P->ctx, -15);
+ return lpz;
+ }
+
+ errno = pj_errno = 0;
+ P->ctx->last_errno = 0;
+
+ xyz.x = (xyz.x * P->to_meter - P->x0) * P->ra; /* descale and de-offset */
+ xyz.y = (xyz.y * P->to_meter - P->y0) * P->ra;
+ //z is not scaled since that is handled by vto_meter before we get here
+
+ //Check for NULL pointer
+ if (P->inv3d != NULL)
+ {
+ lpz = (*P->inv3d)(xyz, P); /* inverse project */
+ if (P->ctx->last_errno )
+ lpz.lam = lpz.phi = lpz.z = HUGE_VAL;
+ else {
+ lpz.lam += P->lam0; /* reduce from del lp.lam */
+ if (!P->over)
+ lpz.lam = adjlon(lpz.lam); /* adjust longitude to CM */
+
+ //This maybe redundant and never user
+ if (P->geoc && fabs(fabs(lpz.phi)-HALFPI) > EPS)
+ lpz.phi = atan(P->one_es * tan(lpz.phi));
+ }
+ }
+ else
+ {
+ lpz.lam = lpz.phi = lpz.z = HUGE_VAL;
+ }
+ return lpz;
+}
diff --git a/src/pj_list.h b/src/pj_list.h
index 194bcc68..20af2eb2 100644
--- a/src/pj_list.h
+++ b/src/pj_list.h
@@ -111,6 +111,7 @@ PROJ_HEAD(qsc, "Quadrilateralized Spherical Cube")
PROJ_HEAD(robin, "Robinson")
PROJ_HEAD(rouss, "Roussilhe Stereographic")
PROJ_HEAD(rpoly, "Rectangular Polyconic")
+PROJ_HEAD(sch, "Spherical Cross-track Height")
PROJ_HEAD(sinu, "Sinusoidal (Sanson-Flamsteed)")
PROJ_HEAD(somerc, "Swiss. Obl. Mercator")
PROJ_HEAD(stere, "Stereographic")
@@ -142,3 +143,4 @@ PROJ_HEAD(weren, "Werenskiold I")
PROJ_HEAD(wink1, "Winkel I")
PROJ_HEAD(wink2, "Winkel II")
PROJ_HEAD(wintri, "Winkel Tripel")
+
diff --git a/src/pj_transform.c b/src/pj_transform.c
index 6fe571c6..32f14955 100644
--- a/src/pj_transform.c
+++ b/src/pj_transform.c
@@ -152,7 +152,9 @@ int pj_transform( PJ *srcdefn, PJ *dstdefn, long point_count, int point_offset,
/* -------------------------------------------------------------------- */
else if( !srcdefn->is_latlong )
{
- if( srcdefn->inv == NULL )
+
+ //Check first if projection is invertible.
+ if( (srcdefn->inv3d == NULL) && (srcdefn->inv == NULL))
{
pj_ctx_set_errno( pj_get_ctx(srcdefn), -17 );
pj_log( pj_get_ctx(srcdefn), PJ_LOG_ERROR,
@@ -160,35 +162,85 @@ int pj_transform( PJ *srcdefn, PJ *dstdefn, long point_count, int point_offset,
return -17;
}
- for( i = 0; i < point_count; i++ )
+ //If invertible - First try inv3d if defined
+ if (srcdefn->inv3d != NULL)
{
- XY projected_loc;
- LP geodetic_loc;
+ //Three dimensions must be defined
+ if ( z == NULL)
+ {
+ pj_ctx_set_errno( pj_get_ctx(srcdefn), PJD_ERR_GEOCENTRIC);
+ return PJD_ERR_GEOCENTRIC;
+ }
- projected_loc.u = x[point_offset*i];
- projected_loc.v = y[point_offset*i];
+ for (i=0; i < point_count; i++)
+ {
+ XYZ projected_loc;
+ XYZ geodetic_loc;
- if( projected_loc.u == HUGE_VAL )
- continue;
+ projected_loc.u = x[point_offset*i];
+ projected_loc.v = y[point_offset*i];
+ projected_loc.w = z[point_offset*i];
- geodetic_loc = pj_inv( projected_loc, srcdefn );
- if( srcdefn->ctx->last_errno != 0 )
- {
- if( (srcdefn->ctx->last_errno != 33 /*EDOM*/
- && srcdefn->ctx->last_errno != 34 /*ERANGE*/ )
- && (srcdefn->ctx->last_errno > 0
- || srcdefn->ctx->last_errno < -44 || point_count == 1
- || transient_error[-srcdefn->ctx->last_errno] == 0 ) )
- return srcdefn->ctx->last_errno;
- else
+ if (projected_loc.u == HUGE_VAL)
+ continue;
+
+ geodetic_loc = pj_inv3d(projected_loc, srcdefn);
+ if( srcdefn->ctx->last_errno != 0 )
{
- geodetic_loc.u = HUGE_VAL;
- geodetic_loc.v = HUGE_VAL;
+ if( (srcdefn->ctx->last_errno != 33 /*EDOM*/
+ && srcdefn->ctx->last_errno != 34 /*ERANGE*/ )
+ && (srcdefn->ctx->last_errno > 0
+ || srcdefn->ctx->last_errno < -44 || point_count == 1
+ || transient_error[-srcdefn->ctx->last_errno] == 0 ) )
+ return srcdefn->ctx->last_errno;
+ else
+ {
+ geodetic_loc.u = HUGE_VAL;
+ geodetic_loc.v = HUGE_VAL;
+ geodetic_loc.w = HUGE_VAL;
+ }
}
+
+ x[point_offset*i] = geodetic_loc.u;
+ y[point_offset*i] = geodetic_loc.v;
+ z[point_offset*i] = geodetic_loc.w;
+
}
- x[point_offset*i] = geodetic_loc.u;
- y[point_offset*i] = geodetic_loc.v;
+ }
+ else
+ {
+ //Fallback to the original PROJ.4 API 2d inversion- inv
+ for( i = 0; i < point_count; i++ )
+ {
+ XY projected_loc;
+ LP geodetic_loc;
+
+ projected_loc.u = x[point_offset*i];
+ projected_loc.v = y[point_offset*i];
+
+ if( projected_loc.u == HUGE_VAL )
+ continue;
+
+ geodetic_loc = pj_inv( projected_loc, srcdefn );
+ if( srcdefn->ctx->last_errno != 0 )
+ {
+ if( (srcdefn->ctx->last_errno != 33 /*EDOM*/
+ && srcdefn->ctx->last_errno != 34 /*ERANGE*/ )
+ && (srcdefn->ctx->last_errno > 0
+ || srcdefn->ctx->last_errno < -44 || point_count == 1
+ || transient_error[-srcdefn->ctx->last_errno] == 0 ) )
+ return srcdefn->ctx->last_errno;
+ else
+ {
+ geodetic_loc.u = HUGE_VAL;
+ geodetic_loc.v = HUGE_VAL;
+ }
+ }
+
+ x[point_offset*i] = geodetic_loc.u;
+ y[point_offset*i] = geodetic_loc.v;
+ }
}
}
/* -------------------------------------------------------------------- */
@@ -289,35 +341,76 @@ int pj_transform( PJ *srcdefn, PJ *dstdefn, long point_count, int point_offset,
/* -------------------------------------------------------------------- */
else if( !dstdefn->is_latlong )
{
- for( i = 0; i < point_count; i++ )
+
+ if( dstdefn->fwd3d != NULL)
{
- XY projected_loc;
- LP geodetic_loc;
+ for( i = 0; i < point_count; i++ )
+ {
+ XYZ projected_loc;
+ LPZ geodetic_loc;
+
+ geodetic_loc.u = x[point_offset*i];
+ geodetic_loc.v = y[point_offset*i];
+ geodetic_loc.w = z[point_offset*i];
- geodetic_loc.u = x[point_offset*i];
- geodetic_loc.v = y[point_offset*i];
+ if (geodetic_loc.u == HUGE_VAL)
+ continue;
- if( geodetic_loc.u == HUGE_VAL )
- continue;
+ projected_loc = pj_fwd3d( geodetic_loc, dstdefn);
+ if( dstdefn->ctx->last_errno != 0 )
+ {
+ if( (dstdefn->ctx->last_errno != 33 /*EDOM*/
+ && dstdefn->ctx->last_errno != 34 /*ERANGE*/ )
+ && (dstdefn->ctx->last_errno > 0
+ || dstdefn->ctx->last_errno < -44 || point_count == 1
+ || transient_error[-dstdefn->ctx->last_errno] == 0 ) )
+ return dstdefn->ctx->last_errno;
+ else
+ {
+ projected_loc.u = HUGE_VAL;
+ projected_loc.v = HUGE_VAL;
+ projected_loc.w = HUGE_VAL;
+ }
+ }
+
+ x[point_offset*i] = projected_loc.u;
+ y[point_offset*i] = projected_loc.v;
+ z[point_offset*i] = projected_loc.w;
+ }
- projected_loc = pj_fwd( geodetic_loc, dstdefn );
- if( dstdefn->ctx->last_errno != 0 )
+ }
+ else
+ {
+ for( i = 0; i < point_count; i++ )
{
- if( (dstdefn->ctx->last_errno != 33 /*EDOM*/
- && dstdefn->ctx->last_errno != 34 /*ERANGE*/ )
- && (dstdefn->ctx->last_errno > 0
- || dstdefn->ctx->last_errno < -44 || point_count == 1
- || transient_error[-dstdefn->ctx->last_errno] == 0 ) )
- return dstdefn->ctx->last_errno;
- else
+ XY projected_loc;
+ LP geodetic_loc;
+
+ geodetic_loc.u = x[point_offset*i];
+ geodetic_loc.v = y[point_offset*i];
+
+ if( geodetic_loc.u == HUGE_VAL )
+ continue;
+
+ projected_loc = pj_fwd( geodetic_loc, dstdefn );
+ if( dstdefn->ctx->last_errno != 0 )
{
- projected_loc.u = HUGE_VAL;
- projected_loc.v = HUGE_VAL;
- }
+ if( (dstdefn->ctx->last_errno != 33 /*EDOM*/
+ && dstdefn->ctx->last_errno != 34 /*ERANGE*/ )
+ && (dstdefn->ctx->last_errno > 0
+ || dstdefn->ctx->last_errno < -44 || point_count == 1
+ || transient_error[-dstdefn->ctx->last_errno] == 0 ) )
+ return dstdefn->ctx->last_errno;
+ else
+ {
+ projected_loc.u = HUGE_VAL;
+ projected_loc.v = HUGE_VAL;
+ }
+ }
+
+ x[point_offset*i] = projected_loc.u;
+ y[point_offset*i] = projected_loc.v;
}
-
- x[point_offset*i] = projected_loc.u;
- y[point_offset*i] = projected_loc.v;
}
}
diff --git a/src/proj.def b/src/proj.def
index f3146551..c872e6aa 100644
--- a/src/proj.def
+++ b/src/proj.def
@@ -74,3 +74,5 @@ EXPORTS
pj_open_lib @72
pj_atof @73
pj_strtod @74
+ pj_fwd3d @75
+ pj_inv3d @76
diff --git a/src/proj_api.h b/src/proj_api.h
index 9e1e49a8..e381815c 100644
--- a/src/proj_api.h
+++ b/src/proj_api.h
@@ -54,15 +54,20 @@ extern int pj_errno; /* global error return code */
#if !defined(PROJECTS_H)
typedef struct { double u, v; } projUV;
+ typedef struct { double u, v, w; } projUVW;
typedef void *projPJ;
#define projXY projUV
#define projLP projUV
+ #define projXYZ projUVW
+ #define projLPZ projUVW
typedef void *projCtx;
#else
typedef PJ *projPJ;
typedef projCtx_t *projCtx;
# define projXY XY
# define projLP LP
+# define projXYZ XYZ
+# define projLPZ LPZ
#endif
/* file reading api, like stdio */
@@ -80,6 +85,9 @@ typedef struct projFileAPI_t {
projXY pj_fwd(projLP, projPJ);
projLP pj_inv(projXY, projPJ);
+projXYZ pj_fwd3d(projLPZ, projPJ);
+projLPZ pj_inv3d(projXYZ, projPJ);
+
int pj_transform( projPJ src, projPJ dst, long point_count, int point_offset,
double *x, double *y, double *z );
int pj_datum_transform( projPJ src, projPJ dst, long point_count, int point_offset,
diff --git a/src/projects.h b/src/projects.h
index 43287849..0b1d5b3e 100644
--- a/src/projects.h
+++ b/src/projects.h
@@ -147,13 +147,18 @@ typedef struct {
typedef struct { double u, v; } projUV;
typedef struct { double r, i; } COMPLEX;
+typedef struct { double u, v, w; } projUVW;
#ifndef PJ_LIB__
#define XY projUV
#define LP projUV
+#define XYZ projUVW
+#define LPZ projUVW
#else
typedef struct { double x, y; } XY;
typedef struct { double lam, phi; } LP;
+typedef struct { double x, y, z; } XYZ;
+typedef struct { double lam, phi, z; } LPZ;
#endif
typedef union { double f; int i; char *s; } PROJVALUE;
@@ -225,6 +230,8 @@ typedef struct PJconsts {
projCtx_t *ctx;
XY (*fwd)(LP, struct PJconsts *);
LP (*inv)(XY, struct PJconsts *);
+ XYZ (*fwd3d)(LPZ, struct PJconsts *);
+ LPZ (*inv3d)(XYZ, struct PJconsts *);
void (*spc)(LP, struct PJconsts *, struct FACTORS *);
void (*pfree)(struct PJconsts *);
const char *descr;
@@ -324,6 +331,7 @@ extern struct PJ_PRIME_MERIDIANS pj_prime_meridians[];
if( (P = (PJ*) pj_malloc(sizeof(PJ))) != NULL) { \
memset( P, 0, sizeof(PJ) ); \
P->pfree = freeup; P->fwd = 0; P->inv = 0; \
+ P->fwd3d = 0; P->inv3d = 0; \
P->spc = 0; P->descr = des_##name;
#define ENTRYX } return P; } else {
#define ENTRY0(name) ENTRYA(name) ENTRYX
@@ -333,9 +341,13 @@ extern struct PJ_PRIME_MERIDIANS pj_prime_meridians[];
#define E_ERROR(err) { pj_ctx_set_errno( P->ctx, err); freeup(P); return(0); }
#define E_ERROR_0 { freeup(P); return(0); }
#define F_ERROR { pj_ctx_set_errno( P->ctx, -20); return(xy); }
+#define F3_ERROR { pj_ctx_set_errno( P->ctx, -20); return(xyz); }
#define I_ERROR { pj_ctx_set_errno( P->ctx, -20); return(lp); }
+#define I3_ERROR { pj_ctx_set_errno( P->ctx, -20); return(lpz); }
#define FORWARD(name) static XY name(LP lp, PJ *P) { XY xy = {0.0,0.0}
#define INVERSE(name) static LP name(XY xy, PJ *P) { LP lp = {0.0,0.0}
+#define FORWARD3D(name) static XYZ name(LPZ lpz, PJ *P) {XYZ xyz = {0.0, 0.0, 0.0}
+#define INVERSE3D(name) static LPZ name(XYZ xyz, PJ *P) {LPZ lpz = {0.0, 0.0, 0.0}
#define FREEUP static void freeup(PJ *P) {
#define SPECIAL(name) static void name(LP lp, PJ *P, struct FACTORS *fac)
#endif
diff --git a/wince/msvc80/projce_dll/projce_dll.vcproj b/wince/msvc80/projce_dll/projce_dll.vcproj
index 37102afc..fceb5802 100644
--- a/wince/msvc80/projce_dll/projce_dll.vcproj
+++ b/wince/msvc80/projce_dll/projce_dll.vcproj
@@ -1,987 +1,411 @@
-<?xml version="1.0" encoding="windows-1250"?>
-<VisualStudioProject
- ProjectType="Visual C++"
- Version="8.00"
- Name="projce_dll"
- ProjectGUID="{A5AFA635-6DD3-4437-9115-13C9B57138BE}"
- Keyword="Win32Proj"
- >
- <Platforms>
- <Platform
- Name="Pocket PC 2003 (ARMV4)"
- />
- <Platform
- Name="Windows Mobile 5.0 Pocket PC SDK (ARMV4I)"
- />
- </Platforms>
- <ToolFiles>
+<?xml version="1.0" encoding="UTF-8"?>
+<VisualStudioProject ProjectType="Visual C++" Version="8.00" Name="projce_dll" ProjectGUID="{A5AFA635-6DD3-4437-9115-13C9B57138BE}" Keyword="Win32Proj">
+ <Platforms>
+ <Platform Name="Pocket PC 2003 (ARMV4)"/>
+ <Platform Name="Windows Mobile 5.0 Pocket PC SDK (ARMV4I)"/>
+ </Platforms>
+ <ToolFiles>
</ToolFiles>
- <Configurations>
- <Configuration
- Name="Debug|Pocket PC 2003 (ARMV4)"
- OutputDirectory="$(PlatformName)\$(ConfigurationName)"
- IntermediateDirectory="$(PlatformName)\$(ConfigurationName)"
- ConfigurationType="2"
- InheritedPropertySheets="..\projce_common.vsprops"
- CharacterSet="1"
- >
- <Tool
- Name="VCPreBuildEventTool"
- />
- <Tool
- Name="VCCustomBuildTool"
- />
- <Tool
- Name="VCXMLDataGeneratorTool"
- />
- <Tool
- Name="VCWebServiceProxyGeneratorTool"
- />
- <Tool
- Name="VCMIDLTool"
- />
- <Tool
- Name="VCCLCompilerTool"
- ExecutionBucket="7"
- Optimization="0"
- AdditionalIncludeDirectories="..\..\..\src"
- PreprocessorDefinitions="_DEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES);WINCE;DEBUG;_WINDOWS;_USRDLL;PROJCE_DLL_EXPORTS;$(ARCHFAM);$(_ARCHFAM_);_UNICODE;UNICODE"
- MinimalRebuild="true"
- RuntimeLibrary="1"
- BufferSecurityCheck="false"
- UsePrecompiledHeader="0"
- WarningLevel="3"
- DebugInformationFormat="3"
- />
- <Tool
- Name="VCManagedResourceCompilerTool"
- />
- <Tool
- Name="VCResourceCompilerTool"
- PreprocessorDefinitions="_DEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES)"
- Culture="1033"
- AdditionalIncludeDirectories="$(IntDir)"
- />
- <Tool
- Name="VCPreLinkEventTool"
- />
- <Tool
- Name="VCLinkerTool"
- AdditionalOptions=" /subsystem:windowsce,4.20 /machine:ARM /ARMPADCODE"
- AdditionalDependencies="ccrtrtti.lib"
- OutputFile="$(OutDir)/proj.dll"
- LinkIncremental="2"
- AdditionalLibraryDirectories=""
- ModuleDefinitionFile="..\..\..\src\proj.def"
- DelayLoadDLLs="$(NOINHERIT)"
- GenerateDebugInformation="true"
- ProgramDatabaseFile="$(OutDir)/proj_dll.pdb"
- SubSystem="0"
- ImportLibrary="$(OutDir)/proj_i.lib"
- />
- <Tool
- Name="VCALinkTool"
- />
- <Tool
- Name="VCXDCMakeTool"
- />
- <Tool
- Name="VCBscMakeTool"
- />
- <Tool
- Name="VCCodeSignTool"
- />
- <Tool
- Name="VCPostBuildEventTool"
- />
- <DeploymentTool
- ForceDirty="-1"
- RemoteDirectory=""
- RegisterOutput="0"
- AdditionalFiles=""
- />
- <DebuggerTool
- />
- </Configuration>
- <Configuration
- Name="Debug|Windows Mobile 5.0 Pocket PC SDK (ARMV4I)"
- OutputDirectory="$(PlatformName)\$(ConfigurationName)"
- IntermediateDirectory="$(PlatformName)\$(ConfigurationName)"
- ConfigurationType="2"
- InheritedPropertySheets="..\projce_common.vsprops"
- CharacterSet="1"
- >
- <Tool
- Name="VCPreBuildEventTool"
- />
- <Tool
- Name="VCCustomBuildTool"
- />
- <Tool
- Name="VCXMLDataGeneratorTool"
- />
- <Tool
- Name="VCWebServiceProxyGeneratorTool"
- />
- <Tool
- Name="VCMIDLTool"
- />
- <Tool
- Name="VCCLCompilerTool"
- ExecutionBucket="7"
- Optimization="0"
- AdditionalIncludeDirectories="..\..\..\src"
- PreprocessorDefinitions="_DEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES);WINCE;DEBUG;_WINDOWS;_USRDLL;PROJCE_DLL_EXPORTS;$(ARCHFAM);$(_ARCHFAM_);_UNICODE;UNICODE"
- MinimalRebuild="true"
- RuntimeLibrary="1"
- UsePrecompiledHeader="0"
- WarningLevel="3"
- DebugInformationFormat="3"
- />
- <Tool
- Name="VCManagedResourceCompilerTool"
- />
- <Tool
- Name="VCResourceCompilerTool"
- PreprocessorDefinitions="_DEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES)"
- Culture="1033"
- AdditionalIncludeDirectories="$(IntDir)"
- />
- <Tool
- Name="VCPreLinkEventTool"
- />
- <Tool
- Name="VCLinkerTool"
- AdditionalOptions=" /subsystem:windowsce,5.01"
- OutputFile="$(OutDir)/proj.dll"
- LinkIncremental="2"
- DelayLoadDLLs="$(NOINHERIT)"
- GenerateDebugInformation="true"
- ProgramDatabaseFile="$(OutDir)/projce_dll.pdb"
- SubSystem="0"
- ImportLibrary="$(OutDir)/proj_i.lib"
- />
- <Tool
- Name="VCALinkTool"
- />
- <Tool
- Name="VCXDCMakeTool"
- />
- <Tool
- Name="VCBscMakeTool"
- />
- <Tool
- Name="VCCodeSignTool"
- />
- <Tool
- Name="VCPostBuildEventTool"
- />
- <DeploymentTool
- ForceDirty="-1"
- RemoteDirectory=""
- RegisterOutput="0"
- AdditionalFiles=""
- />
- <DebuggerTool
- />
- </Configuration>
- <Configuration
- Name="Release|Pocket PC 2003 (ARMV4)"
- OutputDirectory="$(PlatformName)\$(ConfigurationName)"
- IntermediateDirectory="$(PlatformName)\$(ConfigurationName)"
- ConfigurationType="2"
- InheritedPropertySheets="..\projce_common.vsprops"
- CharacterSet="1"
- >
- <Tool
- Name="VCPreBuildEventTool"
- />
- <Tool
- Name="VCCustomBuildTool"
- />
- <Tool
- Name="VCXMLDataGeneratorTool"
- />
- <Tool
- Name="VCWebServiceProxyGeneratorTool"
- />
- <Tool
- Name="VCMIDLTool"
- />
- <Tool
- Name="VCCLCompilerTool"
- ExecutionBucket="7"
- Optimization="2"
- AdditionalIncludeDirectories="..\..\..\src"
- PreprocessorDefinitions="NDEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES);WINCE;_WINDOWS;_USRDLL;PROJCE_DLL_EXPORTS;$(ARCHFAM);$(_ARCHFAM_);_UNICODE;UNICODE"
- RuntimeLibrary="0"
- BufferSecurityCheck="false"
- UsePrecompiledHeader="0"
- WarningLevel="3"
- DebugInformationFormat="3"
- />
- <Tool
- Name="VCManagedResourceCompilerTool"
- />
- <Tool
- Name="VCResourceCompilerTool"
- PreprocessorDefinitions="NDEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES)"
- Culture="1033"
- AdditionalIncludeDirectories="$(IntDir)"
- />
- <Tool
- Name="VCPreLinkEventTool"
- />
- <Tool
- Name="VCLinkerTool"
- AdditionalOptions=" /subsystem:windowsce,4.20 /machine:ARM /ARMPADCODE"
- OutputFile="$(OutDir)/proj.dll"
- LinkIncremental="1"
- ModuleDefinitionFile="..\..\..\src\proj.def"
- DelayLoadDLLs="$(NOINHERIT)"
- GenerateDebugInformation="true"
- ProgramDatabaseFile="$(OutDir)/projce_dll.pdb"
- SubSystem="0"
- OptimizeReferences="2"
- EnableCOMDATFolding="2"
- ImportLibrary="$(OutDir)/proj_i.lib"
- />
- <Tool
- Name="VCALinkTool"
- />
- <Tool
- Name="VCXDCMakeTool"
- />
- <Tool
- Name="VCBscMakeTool"
- />
- <Tool
- Name="VCCodeSignTool"
- />
- <Tool
- Name="VCPostBuildEventTool"
- />
- <DeploymentTool
- ForceDirty="-1"
- RemoteDirectory=""
- RegisterOutput="0"
- AdditionalFiles=""
- />
- <DebuggerTool
- />
- </Configuration>
- <Configuration
- Name="Release|Windows Mobile 5.0 Pocket PC SDK (ARMV4I)"
- OutputDirectory="$(PlatformName)\$(ConfigurationName)"
- IntermediateDirectory="$(PlatformName)\$(ConfigurationName)"
- ConfigurationType="2"
- InheritedPropertySheets="..\projce_common.vsprops"
- CharacterSet="1"
- >
- <Tool
- Name="VCPreBuildEventTool"
- />
- <Tool
- Name="VCCustomBuildTool"
- />
- <Tool
- Name="VCXMLDataGeneratorTool"
- />
- <Tool
- Name="VCWebServiceProxyGeneratorTool"
- />
- <Tool
- Name="VCMIDLTool"
- />
- <Tool
- Name="VCCLCompilerTool"
- ExecutionBucket="7"
- Optimization="2"
- AdditionalIncludeDirectories="..\..\..\src"
- PreprocessorDefinitions="NDEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES);WINCE;_WINDOWS;_USRDLL;PROJCE_DLL_EXPORTS;$(ARCHFAM);$(_ARCHFAM_);_UNICODE;UNICODE"
- RuntimeLibrary="0"
- UsePrecompiledHeader="0"
- WarningLevel="3"
- DebugInformationFormat="3"
- />
- <Tool
- Name="VCManagedResourceCompilerTool"
- />
- <Tool
- Name="VCResourceCompilerTool"
- PreprocessorDefinitions="NDEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES)"
- Culture="1033"
- AdditionalIncludeDirectories="$(IntDir)"
- />
- <Tool
- Name="VCPreLinkEventTool"
- />
- <Tool
- Name="VCLinkerTool"
- AdditionalOptions=" /subsystem:windowsce,5.01"
- OutputFile="$(OutDir)/proj.dll"
- LinkIncremental="1"
- DelayLoadDLLs="$(NOINHERIT)"
- GenerateDebugInformation="true"
- ProgramDatabaseFile="$(OutDir)/projce_dll.pdb"
- SubSystem="0"
- OptimizeReferences="2"
- EnableCOMDATFolding="2"
- ImportLibrary="$(OutDir)/proj_i.lib"
- />
- <Tool
- Name="VCALinkTool"
- />
- <Tool
- Name="VCXDCMakeTool"
- />
- <Tool
- Name="VCBscMakeTool"
- />
- <Tool
- Name="VCCodeSignTool"
- />
- <Tool
- Name="VCPostBuildEventTool"
- />
- <DeploymentTool
- ForceDirty="-1"
- RemoteDirectory=""
- RegisterOutput="0"
- AdditionalFiles=""
- />
- <DebuggerTool
- />
- </Configuration>
- </Configurations>
- <References>
+ <Configurations>
+ <Configuration Name="Debug|Pocket PC 2003 (ARMV4)" OutputDirectory="$(PlatformName)\$(ConfigurationName)" IntermediateDirectory="$(PlatformName)\$(ConfigurationName)" ConfigurationType="2" InheritedPropertySheets="..\projce_common.vsprops" CharacterSet="1">
+ <Tool Name="VCPreBuildEventTool"/>
+ <Tool Name="VCCustomBuildTool"/>
+ <Tool Name="VCXMLDataGeneratorTool"/>
+ <Tool Name="VCWebServiceProxyGeneratorTool"/>
+ <Tool Name="VCMIDLTool"/>
+ <Tool Name="VCCLCompilerTool" ExecutionBucket="7" Optimization="0" AdditionalIncludeDirectories="..\..\..\src" PreprocessorDefinitions="_DEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES);WINCE;DEBUG;_WINDOWS;_USRDLL;PROJCE_DLL_EXPORTS;$(ARCHFAM);$(_ARCHFAM_);_UNICODE;UNICODE" MinimalRebuild="true" RuntimeLibrary="1" BufferSecurityCheck="false" UsePrecompiledHeader="0" WarningLevel="3" DebugInformationFormat="3"/>
+ <Tool Name="VCManagedResourceCompilerTool"/>
+ <Tool Name="VCResourceCompilerTool" PreprocessorDefinitions="_DEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES)" Culture="1033" AdditionalIncludeDirectories="$(IntDir)"/>
+ <Tool Name="VCPreLinkEventTool"/>
+ <Tool Name="VCLinkerTool" AdditionalOptions=" /subsystem:windowsce,4.20 /machine:ARM /ARMPADCODE" AdditionalDependencies="ccrtrtti.lib" OutputFile="$(OutDir)/proj.dll" LinkIncremental="2" AdditionalLibraryDirectories="" ModuleDefinitionFile="..\..\..\src\proj.def" DelayLoadDLLs="$(NOINHERIT)" GenerateDebugInformation="true" ProgramDatabaseFile="$(OutDir)/proj_dll.pdb" SubSystem="0" ImportLibrary="$(OutDir)/proj_i.lib"/>
+ <Tool Name="VCALinkTool"/>
+ <Tool Name="VCXDCMakeTool"/>
+ <Tool Name="VCBscMakeTool"/>
+ <Tool Name="VCCodeSignTool"/>
+ <Tool Name="VCPostBuildEventTool"/>
+ <DeploymentTool ForceDirty="-1" RemoteDirectory="" RegisterOutput="0" AdditionalFiles=""/>
+ <DebuggerTool/>
+ </Configuration>
+ <Configuration Name="Debug|Windows Mobile 5.0 Pocket PC SDK (ARMV4I)" OutputDirectory="$(PlatformName)\$(ConfigurationName)" IntermediateDirectory="$(PlatformName)\$(ConfigurationName)" ConfigurationType="2" InheritedPropertySheets="..\projce_common.vsprops" CharacterSet="1">
+ <Tool Name="VCPreBuildEventTool"/>
+ <Tool Name="VCCustomBuildTool"/>
+ <Tool Name="VCXMLDataGeneratorTool"/>
+ <Tool Name="VCWebServiceProxyGeneratorTool"/>
+ <Tool Name="VCMIDLTool"/>
+ <Tool Name="VCCLCompilerTool" ExecutionBucket="7" Optimization="0" AdditionalIncludeDirectories="..\..\..\src" PreprocessorDefinitions="_DEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES);WINCE;DEBUG;_WINDOWS;_USRDLL;PROJCE_DLL_EXPORTS;$(ARCHFAM);$(_ARCHFAM_);_UNICODE;UNICODE" MinimalRebuild="true" RuntimeLibrary="1" UsePrecompiledHeader="0" WarningLevel="3" DebugInformationFormat="3"/>
+ <Tool Name="VCManagedResourceCompilerTool"/>
+ <Tool Name="VCResourceCompilerTool" PreprocessorDefinitions="_DEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES)" Culture="1033" AdditionalIncludeDirectories="$(IntDir)"/>
+ <Tool Name="VCPreLinkEventTool"/>
+ <Tool Name="VCLinkerTool" AdditionalOptions=" /subsystem:windowsce,5.01" OutputFile="$(OutDir)/proj.dll" LinkIncremental="2" DelayLoadDLLs="$(NOINHERIT)" GenerateDebugInformation="true" ProgramDatabaseFile="$(OutDir)/projce_dll.pdb" SubSystem="0" ImportLibrary="$(OutDir)/proj_i.lib"/>
+ <Tool Name="VCALinkTool"/>
+ <Tool Name="VCXDCMakeTool"/>
+ <Tool Name="VCBscMakeTool"/>
+ <Tool Name="VCCodeSignTool"/>
+ <Tool Name="VCPostBuildEventTool"/>
+ <DeploymentTool ForceDirty="-1" RemoteDirectory="" RegisterOutput="0" AdditionalFiles=""/>
+ <DebuggerTool/>
+ </Configuration>
+ <Configuration Name="Release|Pocket PC 2003 (ARMV4)" OutputDirectory="$(PlatformName)\$(ConfigurationName)" IntermediateDirectory="$(PlatformName)\$(ConfigurationName)" ConfigurationType="2" InheritedPropertySheets="..\projce_common.vsprops" CharacterSet="1">
+ <Tool Name="VCPreBuildEventTool"/>
+ <Tool Name="VCCustomBuildTool"/>
+ <Tool Name="VCXMLDataGeneratorTool"/>
+ <Tool Name="VCWebServiceProxyGeneratorTool"/>
+ <Tool Name="VCMIDLTool"/>
+ <Tool Name="VCCLCompilerTool" ExecutionBucket="7" Optimization="2" AdditionalIncludeDirectories="..\..\..\src" PreprocessorDefinitions="NDEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES);WINCE;_WINDOWS;_USRDLL;PROJCE_DLL_EXPORTS;$(ARCHFAM);$(_ARCHFAM_);_UNICODE;UNICODE" RuntimeLibrary="0" BufferSecurityCheck="false" UsePrecompiledHeader="0" WarningLevel="3" DebugInformationFormat="3"/>
+ <Tool Name="VCManagedResourceCompilerTool"/>
+ <Tool Name="VCResourceCompilerTool" PreprocessorDefinitions="NDEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES)" Culture="1033" AdditionalIncludeDirectories="$(IntDir)"/>
+ <Tool Name="VCPreLinkEventTool"/>
+ <Tool Name="VCLinkerTool" AdditionalOptions=" /subsystem:windowsce,4.20 /machine:ARM /ARMPADCODE" OutputFile="$(OutDir)/proj.dll" LinkIncremental="1" ModuleDefinitionFile="..\..\..\src\proj.def" DelayLoadDLLs="$(NOINHERIT)" GenerateDebugInformation="true" ProgramDatabaseFile="$(OutDir)/projce_dll.pdb" SubSystem="0" OptimizeReferences="2" EnableCOMDATFolding="2" ImportLibrary="$(OutDir)/proj_i.lib"/>
+ <Tool Name="VCALinkTool"/>
+ <Tool Name="VCXDCMakeTool"/>
+ <Tool Name="VCBscMakeTool"/>
+ <Tool Name="VCCodeSignTool"/>
+ <Tool Name="VCPostBuildEventTool"/>
+ <DeploymentTool ForceDirty="-1" RemoteDirectory="" RegisterOutput="0" AdditionalFiles=""/>
+ <DebuggerTool/>
+ </Configuration>
+ <Configuration Name="Release|Windows Mobile 5.0 Pocket PC SDK (ARMV4I)" OutputDirectory="$(PlatformName)\$(ConfigurationName)" IntermediateDirectory="$(PlatformName)\$(ConfigurationName)" ConfigurationType="2" InheritedPropertySheets="..\projce_common.vsprops" CharacterSet="1">
+ <Tool Name="VCPreBuildEventTool"/>
+ <Tool Name="VCCustomBuildTool"/>
+ <Tool Name="VCXMLDataGeneratorTool"/>
+ <Tool Name="VCWebServiceProxyGeneratorTool"/>
+ <Tool Name="VCMIDLTool"/>
+ <Tool Name="VCCLCompilerTool" ExecutionBucket="7" Optimization="2" AdditionalIncludeDirectories="..\..\..\src" PreprocessorDefinitions="NDEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES);WINCE;_WINDOWS;_USRDLL;PROJCE_DLL_EXPORTS;$(ARCHFAM);$(_ARCHFAM_);_UNICODE;UNICODE" RuntimeLibrary="0" UsePrecompiledHeader="0" WarningLevel="3" DebugInformationFormat="3"/>
+ <Tool Name="VCManagedResourceCompilerTool"/>
+ <Tool Name="VCResourceCompilerTool" PreprocessorDefinitions="NDEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES)" Culture="1033" AdditionalIncludeDirectories="$(IntDir)"/>
+ <Tool Name="VCPreLinkEventTool"/>
+ <Tool Name="VCLinkerTool" AdditionalOptions=" /subsystem:windowsce,5.01" OutputFile="$(OutDir)/proj.dll" LinkIncremental="1" DelayLoadDLLs="$(NOINHERIT)" GenerateDebugInformation="true" ProgramDatabaseFile="$(OutDir)/projce_dll.pdb" SubSystem="0" OptimizeReferences="2" EnableCOMDATFolding="2" ImportLibrary="$(OutDir)/proj_i.lib"/>
+ <Tool Name="VCALinkTool"/>
+ <Tool Name="VCXDCMakeTool"/>
+ <Tool Name="VCBscMakeTool"/>
+ <Tool Name="VCCodeSignTool"/>
+ <Tool Name="VCPostBuildEventTool"/>
+ <DeploymentTool ForceDirty="-1" RemoteDirectory="" RegisterOutput="0" AdditionalFiles=""/>
+ <DebuggerTool/>
+ </Configuration>
+ </Configurations>
+ <References>
</References>
- <Files>
- <Filter
- Name="proj"
- >
- <Filter
- Name="src"
- >
- <File
- RelativePath="..\..\..\src\aasincos.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\adjlon.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\bch2bps.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\bchgen.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\biveval.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\dmstor.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\emess.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\emess.h"
- >
- </File>
- <File
- RelativePath="..\..\..\src\gen_cheb.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\geocent.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\geocent.h"
- >
- </File>
- <File
- RelativePath="..\..\..\src\geod_for.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\geod_inv.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\geod_set.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\geodesic.h"
- >
- </File>
- <File
- RelativePath="..\..\..\src\hypot.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\mk_cheby.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\nad_cvt.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\nad_init.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\nad_intr.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\nad_list.h"
- >
- </File>
- <File
- RelativePath="..\..\..\src\org_proj4_Projections.h"
- >
- </File>
- <File
- RelativePath="..\..\..\src\p_series.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\PJ_aea.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\PJ_aeqd.c"
- >
+ <Files>
+ <Filter Name="proj">
+ <Filter Name="src">
+ <File RelativePath="..\..\..\src\aasincos.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_airy.c"
- >
+ <File RelativePath="..\..\..\src\adjlon.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_aitoff.c"
- >
+ <File RelativePath="..\..\..\src\bch2bps.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_apply_gridshift.c"
- >
+ <File RelativePath="..\..\..\src\bchgen.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_august.c"
- >
+ <File RelativePath="..\..\..\src\biveval.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_auth.c"
- >
+ <File RelativePath="..\..\..\src\dmstor.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_bacon.c"
- >
+ <File RelativePath="..\..\..\src\emess.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_bipc.c"
- >
+ <File RelativePath="..\..\..\src\emess.h">
</File>
- <File
- RelativePath="..\..\..\src\PJ_boggs.c"
- >
+ <File RelativePath="..\..\..\src\gen_cheb.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_bonne.c"
- >
+ <File RelativePath="..\..\..\src\geocent.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_cass.c"
- >
+ <File RelativePath="..\..\..\src\geocent.h">
</File>
- <File
- RelativePath="..\..\..\src\PJ_cc.c"
- >
+ <File RelativePath="..\..\..\src\geod_for.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_cea.c"
- >
+ <File RelativePath="..\..\..\src\geod_inv.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_chamb.c"
- >
+ <File RelativePath="..\..\..\src\geod_set.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_collg.c"
- >
+ <File RelativePath="..\..\..\src\geodesic.h">
</File>
- <File
- RelativePath="..\..\..\src\PJ_crast.c"
- >
+ <File RelativePath="..\..\..\src\hypot.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_datum_set.c"
- >
+ <File RelativePath="..\..\..\src\mk_cheby.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_datums.c"
- >
+ <File RelativePath="..\..\..\src\nad_cvt.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_denoy.c"
- >
+ <File RelativePath="..\..\..\src\nad_init.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_deriv.c"
- >
+ <File RelativePath="..\..\..\src\nad_intr.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_eck1.c"
- >
+ <File RelativePath="..\..\..\src\nad_list.h">
</File>
- <File
- RelativePath="..\..\..\src\PJ_eck2.c"
- >
+ <File RelativePath="..\..\..\src\org_proj4_Projections.h">
</File>
- <File
- RelativePath="..\..\..\src\PJ_eck3.c"
- >
+ <File RelativePath="..\..\..\src\p_series.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_eck4.c"
- >
+ <File RelativePath="..\..\..\src\PJ_aea.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_eck5.c"
- >
+ <File RelativePath="..\..\..\src\PJ_aeqd.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_ell_set.c"
- >
+ <File RelativePath="..\..\..\src\PJ_airy.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_ellps.c"
- >
+ <File RelativePath="..\..\..\src\PJ_aitoff.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_eqc.c"
- >
+ <File RelativePath="..\..\..\src\pj_apply_gridshift.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_eqdc.c"
- >
+ <File RelativePath="..\..\..\src\PJ_august.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_errno.c"
- >
+ <File RelativePath="..\..\..\src\pj_auth.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_factors.c"
- >
+ <File RelativePath="..\..\..\src\PJ_bacon.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_fahey.c"
- >
+ <File RelativePath="..\..\..\src\PJ_bipc.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_fouc_s.c"
- >
+ <File RelativePath="..\..\..\src\PJ_boggs.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_fwd.c"
- >
+ <File RelativePath="..\..\..\src\PJ_bonne.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_gall.c"
- >
+ <File RelativePath="..\..\..\src\PJ_cass.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_gauss.c"
- >
+ <File RelativePath="..\..\..\src\PJ_cc.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_geocent.c"
- >
+ <File RelativePath="..\..\..\src\PJ_cea.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_geos.c"
- >
+ <File RelativePath="..\..\..\src\PJ_chamb.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_gins8.c"
- >
+ <File RelativePath="..\..\..\src\PJ_collg.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_gn_sinu.c"
- >
+ <File RelativePath="..\..\..\src\PJ_crast.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_gnom.c"
- >
+ <File RelativePath="..\..\..\src\pj_datum_set.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_goode.c"
- >
+ <File RelativePath="..\..\..\src\pj_datums.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_gridinfo.c"
- >
+ <File RelativePath="..\..\..\src\PJ_denoy.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_gridlist.c"
- >
+ <File RelativePath="..\..\..\src\pj_deriv.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_hammer.c"
- >
+ <File RelativePath="..\..\..\src\PJ_eck1.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_hatano.c"
- >
+ <File RelativePath="..\..\..\src\PJ_eck2.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_imw_p.c"
- >
+ <File RelativePath="..\..\..\src\PJ_eck3.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_init.c"
- >
+ <File RelativePath="..\..\..\src\PJ_eck4.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_inv.c"
- >
+ <File RelativePath="..\..\..\src\PJ_eck5.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_krovak.c"
- >
+ <File RelativePath="..\..\..\src\pj_ell_set.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_labrd.c"
- >
+ <File RelativePath="..\..\..\src\pj_ellps.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_laea.c"
- >
+ <File RelativePath="..\..\..\src\PJ_eqc.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_lagrng.c"
- >
+ <File RelativePath="..\..\..\src\PJ_eqdc.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_larr.c"
- >
+ <File RelativePath="..\..\..\src\pj_errno.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_lask.c"
- >
+ <File RelativePath="..\..\..\src\pj_factors.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_latlong.c"
- >
+ <File RelativePath="..\..\..\src\PJ_fahey.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_lcc.c"
- >
+ <File RelativePath="..\..\..\src\PJ_fouc_s.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_lcca.c"
- >
+ <File RelativePath="..\..\..\src\pj_fwd.c">
+ </File>
+ <File RelativePath="..\..\..\src\pj_fwd3d.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_gall.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_list.c"
- >
+ <File RelativePath="..\..\..\src\pj_gauss.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_list.h"
- >
+ <File RelativePath="..\..\..\src\pj_geocent.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_loxim.c"
- >
+ <File RelativePath="..\..\..\src\PJ_geos.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_lsat.c"
- >
+ <File RelativePath="..\..\..\src\PJ_gins8.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_malloc.c"
- >
+ <File RelativePath="..\..\..\src\PJ_gn_sinu.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_mbt_fps.c"
- >
+ <File RelativePath="..\..\..\src\PJ_gnom.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_mbtfpp.c"
- >
+ <File RelativePath="..\..\..\src\PJ_goode.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_mbtfpq.c"
- >
+ <File RelativePath="..\..\..\src\pj_gridinfo.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_merc.c"
- >
+ <File RelativePath="..\..\..\src\pj_gridlist.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_mill.c"
- >
+ <File RelativePath="..\..\..\src\PJ_hammer.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_mlfn.c"
- >
+ <File RelativePath="..\..\..\src\PJ_hatano.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_mod_ster.c"
- >
+ <File RelativePath="..\..\..\src\PJ_imw_p.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_moll.c"
- >
+ <File RelativePath="..\..\..\src\pj_init.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_mpoly.c"
- >
+ <File RelativePath="..\..\..\src\pj_inv.c">
+ </File>
+ <File RelativePath="..\..\..\src\pj_inv3d.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_krovak.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_msfn.c"
- >
+ <File RelativePath="..\..\..\src\PJ_labrd.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_nell.c"
- >
+ <File RelativePath="..\..\..\src\PJ_laea.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_nell_h.c"
- >
+ <File RelativePath="..\..\..\src\PJ_lagrng.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_nocol.c"
- >
+ <File RelativePath="..\..\..\src\PJ_larr.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_nsper.c"
- >
+ <File RelativePath="..\..\..\src\PJ_lask.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_nzmg.c"
- >
+ <File RelativePath="..\..\..\src\pj_latlong.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_ob_tran.c"
- >
+ <File RelativePath="..\..\..\src\PJ_lcc.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_ocea.c"
- >
+ <File RelativePath="..\..\..\src\PJ_lcca.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_oea.c"
- >
+ <File RelativePath="..\..\..\src\pj_list.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_omerc.c"
- >
+ <File RelativePath="..\..\..\src\pj_list.h">
</File>
- <File
- RelativePath="..\..\..\src\pj_open_lib.c"
- >
+ <File RelativePath="..\..\..\src\PJ_loxim.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_ortho.c"
- >
+ <File RelativePath="..\..\..\src\PJ_lsat.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_param.c"
- >
+ <File RelativePath="..\..\..\src\pj_malloc.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_phi2.c"
- >
+ <File RelativePath="..\..\..\src\PJ_mbt_fps.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_poly.c"
- >
+ <File RelativePath="..\..\..\src\PJ_mbtfpp.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_pr_list.c"
- >
+ <File RelativePath="..\..\..\src\PJ_mbtfpq.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_putp2.c"
- >
+ <File RelativePath="..\..\..\src\PJ_merc.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_putp3.c"
- >
+ <File RelativePath="..\..\..\src\PJ_mill.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_putp4p.c"
- >
+ <File RelativePath="..\..\..\src\pj_mlfn.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_putp5.c"
- >
+ <File RelativePath="..\..\..\src\PJ_mod_ster.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_putp6.c"
- >
+ <File RelativePath="..\..\..\src\PJ_moll.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_qsfn.c"
- >
+ <File RelativePath="..\..\..\src\PJ_mpoly.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_release.c"
- >
+ <File RelativePath="..\..\..\src\pj_msfn.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_robin.c"
- >
+ <File RelativePath="..\..\..\src\PJ_nell.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_rpoly.c"
- >
+ <File RelativePath="..\..\..\src\PJ_nell_h.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_sconics.c"
- >
+ <File RelativePath="..\..\..\src\PJ_nocol.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_somerc.c"
- >
+ <File RelativePath="..\..\..\src\PJ_nsper.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_stere.c"
- >
+ <File RelativePath="..\..\..\src\PJ_nzmg.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_sterea.c"
- >
+ <File RelativePath="..\..\..\src\PJ_ob_tran.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_strerrno.c"
- >
+ <File RelativePath="..\..\..\src\PJ_ocea.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_sts.c"
- >
+ <File RelativePath="..\..\..\src\PJ_oea.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_tcc.c"
- >
+ <File RelativePath="..\..\..\src\PJ_omerc.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_tcea.c"
- >
+ <File RelativePath="..\..\..\src\pj_open_lib.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_tmerc.c"
- >
+ <File RelativePath="..\..\..\src\PJ_ortho.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_tpeqd.c"
- >
+ <File RelativePath="..\..\..\src\pj_param.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_transform.c"
- >
+ <File RelativePath="..\..\..\src\pj_phi2.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_tsfn.c"
- >
+ <File RelativePath="..\..\..\src\PJ_poly.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_units.c"
- >
+ <File RelativePath="..\..\..\src\pj_pr_list.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_urm5.c"
- >
+ <File RelativePath="..\..\..\src\PJ_putp2.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_urmfps.c"
- >
+ <File RelativePath="..\..\..\src\PJ_putp3.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_utils.c"
- >
+ <File RelativePath="..\..\..\src\PJ_putp4p.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_vandg.c"
- >
+ <File RelativePath="..\..\..\src\PJ_putp5.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_vandg2.c"
- >
+ <File RelativePath="..\..\..\src\PJ_putp6.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_vandg4.c"
- >
+ <File RelativePath="..\..\..\src\pj_qsfn.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_wag2.c"
- >
+ <File RelativePath="..\..\..\src\pj_release.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_wag3.c"
- >
+ <File RelativePath="..\..\..\src\PJ_robin.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_wag7.c"
- >
+ <File RelativePath="..\..\..\src\PJ_rpoly.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_sch.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_sconics.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_wink1.c"
- >
+ <File RelativePath="..\..\..\src\PJ_somerc.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_wink2.c"
- >
+ <File RelativePath="..\..\..\src\PJ_stere.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_zpoly1.c"
- >
+ <File RelativePath="..\..\..\src\PJ_sterea.c">
</File>
- <File
- RelativePath="..\..\..\src\proj.def"
- >
+ <File RelativePath="..\..\..\src\pj_strerrno.c">
</File>
- <File
- RelativePath="..\..\..\src\proj_api.h"
- >
+ <File RelativePath="..\..\..\src\PJ_sts.c">
</File>
- <File
- RelativePath="..\..\..\src\proj_config.h"
- >
+ <File RelativePath="..\..\..\src\PJ_tcc.c">
</File>
- <File
- RelativePath="..\..\..\src\proj_mdist.c"
- >
+ <File RelativePath="..\..\..\src\PJ_tcea.c">
</File>
- <File
- RelativePath="..\..\..\src\proj_rouss.c"
- >
+ <File RelativePath="..\..\..\src\PJ_tmerc.c">
</File>
- <File
- RelativePath="..\..\..\src\projects.h"
- >
+ <File RelativePath="..\..\..\src\PJ_tpeqd.c">
</File>
- <File
- RelativePath="..\..\..\src\rtodms.c"
- >
+ <File RelativePath="..\..\..\src\pj_transform.c">
</File>
- <File
- RelativePath="..\..\..\src\vector1.c"
- >
+ <File RelativePath="..\..\..\src\pj_tsfn.c">
</File>
- </Filter>
- </Filter>
- </Files>
- <Globals>
+ <File RelativePath="..\..\..\src\pj_units.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_urm5.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_urmfps.c">
+ </File>
+ <File RelativePath="..\..\..\src\pj_utils.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_vandg.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_vandg2.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_vandg4.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_wag2.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_wag3.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_wag7.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_wink1.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_wink2.c">
+ </File>
+ <File RelativePath="..\..\..\src\pj_zpoly1.c">
+ </File>
+ <File RelativePath="..\..\..\src\proj.def">
+ </File>
+ <File RelativePath="..\..\..\src\proj_api.h">
+ </File>
+ <File RelativePath="..\..\..\src\proj_config.h">
+ </File>
+ <File RelativePath="..\..\..\src\proj_mdist.c">
+ </File>
+ <File RelativePath="..\..\..\src\proj_rouss.c">
+ </File>
+ <File RelativePath="..\..\..\src\projects.h">
+ </File>
+ <File RelativePath="..\..\..\src\rtodms.c">
+ </File>
+ <File RelativePath="..\..\..\src\vector1.c">
+ </File>
+ </Filter>
+ </Filter>
+ </Files>
+ <Globals>
</Globals>
</VisualStudioProject>
diff --git a/wince/msvc80/projce_lib/projce_lib.vcproj b/wince/msvc80/projce_lib/projce_lib.vcproj
index 13f00e35..c5c962d7 100644
--- a/wince/msvc80/projce_lib/projce_lib.vcproj
+++ b/wince/msvc80/projce_lib/projce_lib.vcproj
@@ -1,955 +1,411 @@
-<?xml version="1.0" encoding="windows-1250"?>
-<VisualStudioProject
- ProjectType="Visual C++"
- Version="8.00"
- Name="projce_lib"
- ProjectGUID="{E33BA2AA-25D9-48B1-A9FB-F77EB915AD72}"
- Keyword="Win32Proj"
- >
- <Platforms>
- <Platform
- Name="Pocket PC 2003 (ARMV4)"
- />
- <Platform
- Name="Windows Mobile 5.0 Pocket PC SDK (ARMV4I)"
- />
- </Platforms>
- <ToolFiles>
+<?xml version="1.0" encoding="UTF-8"?>
+<VisualStudioProject ProjectType="Visual C++" Version="8.00" Name="projce_lib" ProjectGUID="{E33BA2AA-25D9-48B1-A9FB-F77EB915AD72}" Keyword="Win32Proj">
+ <Platforms>
+ <Platform Name="Pocket PC 2003 (ARMV4)"/>
+ <Platform Name="Windows Mobile 5.0 Pocket PC SDK (ARMV4I)"/>
+ </Platforms>
+ <ToolFiles>
</ToolFiles>
- <Configurations>
- <Configuration
- Name="Debug|Pocket PC 2003 (ARMV4)"
- OutputDirectory="$(PlatformName)\$(ConfigurationName)"
- IntermediateDirectory="$(PlatformName)\$(ConfigurationName)"
- ConfigurationType="4"
- InheritedPropertySheets="..\projce_common.vsprops"
- CharacterSet="1"
- >
- <Tool
- Name="VCPreBuildEventTool"
- />
- <Tool
- Name="VCCustomBuildTool"
- />
- <Tool
- Name="VCXMLDataGeneratorTool"
- />
- <Tool
- Name="VCWebServiceProxyGeneratorTool"
- />
- <Tool
- Name="VCMIDLTool"
- />
- <Tool
- Name="VCCLCompilerTool"
- ExecutionBucket="7"
- Optimization="0"
- AdditionalIncludeDirectories="..\..\..\src"
- PreprocessorDefinitions="_DEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES);WINCE;DEBUG;_LIB;$(ARCHFAM);$(_ARCHFAM_);_UNICODE;UNICODE"
- IgnoreStandardIncludePath="false"
- GeneratePreprocessedFile="0"
- MinimalRebuild="true"
- RuntimeLibrary="1"
- UsePrecompiledHeader="0"
- WarningLevel="3"
- DebugInformationFormat="3"
- />
- <Tool
- Name="VCManagedResourceCompilerTool"
- />
- <Tool
- Name="VCResourceCompilerTool"
- PreprocessorDefinitions="_DEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES)"
- Culture="1033"
- AdditionalIncludeDirectories="$(IntDir)"
- />
- <Tool
- Name="VCPreLinkEventTool"
- />
- <Tool
- Name="VCLibrarianTool"
- AdditionalOptions=" /subsystem:windowsce,4.20 /machine:ARM"
- OutputFile="$(OutDir)/projced.lib"
- />
- <Tool
- Name="VCALinkTool"
- />
- <Tool
- Name="VCXDCMakeTool"
- />
- <Tool
- Name="VCBscMakeTool"
- />
- <Tool
- Name="VCCodeSignTool"
- />
- <Tool
- Name="VCPostBuildEventTool"
- />
- <DeploymentTool
- ForceDirty="-1"
- RemoteDirectory=""
- RegisterOutput="0"
- AdditionalFiles=""
- />
- <DebuggerTool
- />
- </Configuration>
- <Configuration
- Name="Debug|Windows Mobile 5.0 Pocket PC SDK (ARMV4I)"
- OutputDirectory="$(PlatformName)\$(ConfigurationName)"
- IntermediateDirectory="$(PlatformName)\$(ConfigurationName)"
- ConfigurationType="4"
- InheritedPropertySheets="..\projce_common.vsprops"
- CharacterSet="1"
- >
- <Tool
- Name="VCPreBuildEventTool"
- />
- <Tool
- Name="VCCustomBuildTool"
- />
- <Tool
- Name="VCXMLDataGeneratorTool"
- />
- <Tool
- Name="VCWebServiceProxyGeneratorTool"
- />
- <Tool
- Name="VCMIDLTool"
- />
- <Tool
- Name="VCCLCompilerTool"
- ExecutionBucket="7"
- Optimization="0"
- AdditionalIncludeDirectories="..\..\..\src"
- PreprocessorDefinitions="_DEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES);WINCE;DEBUG;_LIB;$(ARCHFAM);$(_ARCHFAM_);_UNICODE;UNICODE"
- MinimalRebuild="true"
- RuntimeLibrary="1"
- UsePrecompiledHeader="0"
- WarningLevel="3"
- DebugInformationFormat="3"
- />
- <Tool
- Name="VCManagedResourceCompilerTool"
- />
- <Tool
- Name="VCResourceCompilerTool"
- PreprocessorDefinitions="_DEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES)"
- Culture="1033"
- AdditionalIncludeDirectories="$(IntDir)"
- />
- <Tool
- Name="VCPreLinkEventTool"
- />
- <Tool
- Name="VCLibrarianTool"
- AdditionalOptions=" /subsystem:windowsce,5.01"
- OutputFile="$(OutDir)/projced.lib"
- />
- <Tool
- Name="VCALinkTool"
- />
- <Tool
- Name="VCXDCMakeTool"
- />
- <Tool
- Name="VCBscMakeTool"
- />
- <Tool
- Name="VCCodeSignTool"
- />
- <Tool
- Name="VCPostBuildEventTool"
- />
- <DeploymentTool
- ForceDirty="-1"
- RemoteDirectory=""
- RegisterOutput="0"
- AdditionalFiles=""
- />
- <DebuggerTool
- />
- </Configuration>
- <Configuration
- Name="Release|Pocket PC 2003 (ARMV4)"
- OutputDirectory="$(PlatformName)\$(ConfigurationName)"
- IntermediateDirectory="$(PlatformName)\$(ConfigurationName)"
- ConfigurationType="4"
- InheritedPropertySheets="..\projce_common.vsprops"
- CharacterSet="1"
- >
- <Tool
- Name="VCPreBuildEventTool"
- />
- <Tool
- Name="VCCustomBuildTool"
- />
- <Tool
- Name="VCXMLDataGeneratorTool"
- />
- <Tool
- Name="VCWebServiceProxyGeneratorTool"
- />
- <Tool
- Name="VCMIDLTool"
- />
- <Tool
- Name="VCCLCompilerTool"
- ExecutionBucket="7"
- Optimization="2"
- AdditionalIncludeDirectories="..\..\..\src"
- PreprocessorDefinitions="NDEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES);WINCE;_LIB;$(ARCHFAM);$(_ARCHFAM_);_UNICODE;UNICODE"
- RuntimeLibrary="0"
- UsePrecompiledHeader="0"
- WarningLevel="3"
- DebugInformationFormat="3"
- />
- <Tool
- Name="VCManagedResourceCompilerTool"
- />
- <Tool
- Name="VCResourceCompilerTool"
- PreprocessorDefinitions="NDEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES)"
- Culture="1033"
- AdditionalIncludeDirectories="$(IntDir)"
- />
- <Tool
- Name="VCPreLinkEventTool"
- />
- <Tool
- Name="VCLibrarianTool"
- AdditionalOptions=" /subsystem:windowsce,4.20 /machine:ARM"
- OutputFile="$(OutDir)/projce.lib"
- />
- <Tool
- Name="VCALinkTool"
- />
- <Tool
- Name="VCXDCMakeTool"
- />
- <Tool
- Name="VCBscMakeTool"
- />
- <Tool
- Name="VCCodeSignTool"
- />
- <Tool
- Name="VCPostBuildEventTool"
- />
- <DeploymentTool
- ForceDirty="-1"
- RemoteDirectory=""
- RegisterOutput="0"
- AdditionalFiles=""
- />
- <DebuggerTool
- />
- </Configuration>
- <Configuration
- Name="Release|Windows Mobile 5.0 Pocket PC SDK (ARMV4I)"
- OutputDirectory="$(PlatformName)\$(ConfigurationName)"
- IntermediateDirectory="$(PlatformName)\$(ConfigurationName)"
- ConfigurationType="4"
- InheritedPropertySheets="..\projce_common.vsprops"
- CharacterSet="1"
- >
- <Tool
- Name="VCPreBuildEventTool"
- />
- <Tool
- Name="VCCustomBuildTool"
- />
- <Tool
- Name="VCXMLDataGeneratorTool"
- />
- <Tool
- Name="VCWebServiceProxyGeneratorTool"
- />
- <Tool
- Name="VCMIDLTool"
- />
- <Tool
- Name="VCCLCompilerTool"
- ExecutionBucket="7"
- Optimization="2"
- AdditionalIncludeDirectories="..\..\..\src"
- PreprocessorDefinitions="NDEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES);WINCE;_LIB;$(ARCHFAM);$(_ARCHFAM_);_UNICODE;UNICODE"
- RuntimeLibrary="0"
- UsePrecompiledHeader="0"
- WarningLevel="3"
- DebugInformationFormat="3"
- />
- <Tool
- Name="VCManagedResourceCompilerTool"
- />
- <Tool
- Name="VCResourceCompilerTool"
- PreprocessorDefinitions="NDEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES)"
- Culture="1033"
- AdditionalIncludeDirectories="$(IntDir)"
- />
- <Tool
- Name="VCPreLinkEventTool"
- />
- <Tool
- Name="VCLibrarianTool"
- AdditionalOptions=" /subsystem:windowsce,5.01"
- OutputFile="$(OutDir)/projce.lib"
- />
- <Tool
- Name="VCALinkTool"
- />
- <Tool
- Name="VCXDCMakeTool"
- />
- <Tool
- Name="VCBscMakeTool"
- />
- <Tool
- Name="VCCodeSignTool"
- />
- <Tool
- Name="VCPostBuildEventTool"
- />
- <DeploymentTool
- ForceDirty="-1"
- RemoteDirectory=""
- RegisterOutput="0"
- AdditionalFiles=""
- />
- <DebuggerTool
- />
- </Configuration>
- </Configurations>
- <References>
+ <Configurations>
+ <Configuration Name="Debug|Pocket PC 2003 (ARMV4)" OutputDirectory="$(PlatformName)\$(ConfigurationName)" IntermediateDirectory="$(PlatformName)\$(ConfigurationName)" ConfigurationType="4" InheritedPropertySheets="..\projce_common.vsprops" CharacterSet="1">
+ <Tool Name="VCPreBuildEventTool"/>
+ <Tool Name="VCCustomBuildTool"/>
+ <Tool Name="VCXMLDataGeneratorTool"/>
+ <Tool Name="VCWebServiceProxyGeneratorTool"/>
+ <Tool Name="VCMIDLTool"/>
+ <Tool Name="VCCLCompilerTool" ExecutionBucket="7" Optimization="0" AdditionalIncludeDirectories="..\..\..\src" PreprocessorDefinitions="_DEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES);WINCE;DEBUG;_LIB;$(ARCHFAM);$(_ARCHFAM_);_UNICODE;UNICODE" IgnoreStandardIncludePath="false" GeneratePreprocessedFile="0" MinimalRebuild="true" RuntimeLibrary="1" UsePrecompiledHeader="0" WarningLevel="3" DebugInformationFormat="3"/>
+ <Tool Name="VCManagedResourceCompilerTool"/>
+ <Tool Name="VCResourceCompilerTool" PreprocessorDefinitions="_DEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES)" Culture="1033" AdditionalIncludeDirectories="$(IntDir)"/>
+ <Tool Name="VCPreLinkEventTool"/>
+ <Tool Name="VCLibrarianTool" AdditionalOptions=" /subsystem:windowsce,4.20 /machine:ARM" OutputFile="$(OutDir)/projced.lib"/>
+ <Tool Name="VCALinkTool"/>
+ <Tool Name="VCXDCMakeTool"/>
+ <Tool Name="VCBscMakeTool"/>
+ <Tool Name="VCCodeSignTool"/>
+ <Tool Name="VCPostBuildEventTool"/>
+ <DeploymentTool ForceDirty="-1" RemoteDirectory="" RegisterOutput="0" AdditionalFiles=""/>
+ <DebuggerTool/>
+ </Configuration>
+ <Configuration Name="Debug|Windows Mobile 5.0 Pocket PC SDK (ARMV4I)" OutputDirectory="$(PlatformName)\$(ConfigurationName)" IntermediateDirectory="$(PlatformName)\$(ConfigurationName)" ConfigurationType="4" InheritedPropertySheets="..\projce_common.vsprops" CharacterSet="1">
+ <Tool Name="VCPreBuildEventTool"/>
+ <Tool Name="VCCustomBuildTool"/>
+ <Tool Name="VCXMLDataGeneratorTool"/>
+ <Tool Name="VCWebServiceProxyGeneratorTool"/>
+ <Tool Name="VCMIDLTool"/>
+ <Tool Name="VCCLCompilerTool" ExecutionBucket="7" Optimization="0" AdditionalIncludeDirectories="..\..\..\src" PreprocessorDefinitions="_DEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES);WINCE;DEBUG;_LIB;$(ARCHFAM);$(_ARCHFAM_);_UNICODE;UNICODE" MinimalRebuild="true" RuntimeLibrary="1" UsePrecompiledHeader="0" WarningLevel="3" DebugInformationFormat="3"/>
+ <Tool Name="VCManagedResourceCompilerTool"/>
+ <Tool Name="VCResourceCompilerTool" PreprocessorDefinitions="_DEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES)" Culture="1033" AdditionalIncludeDirectories="$(IntDir)"/>
+ <Tool Name="VCPreLinkEventTool"/>
+ <Tool Name="VCLibrarianTool" AdditionalOptions=" /subsystem:windowsce,5.01" OutputFile="$(OutDir)/projced.lib"/>
+ <Tool Name="VCALinkTool"/>
+ <Tool Name="VCXDCMakeTool"/>
+ <Tool Name="VCBscMakeTool"/>
+ <Tool Name="VCCodeSignTool"/>
+ <Tool Name="VCPostBuildEventTool"/>
+ <DeploymentTool ForceDirty="-1" RemoteDirectory="" RegisterOutput="0" AdditionalFiles=""/>
+ <DebuggerTool/>
+ </Configuration>
+ <Configuration Name="Release|Pocket PC 2003 (ARMV4)" OutputDirectory="$(PlatformName)\$(ConfigurationName)" IntermediateDirectory="$(PlatformName)\$(ConfigurationName)" ConfigurationType="4" InheritedPropertySheets="..\projce_common.vsprops" CharacterSet="1">
+ <Tool Name="VCPreBuildEventTool"/>
+ <Tool Name="VCCustomBuildTool"/>
+ <Tool Name="VCXMLDataGeneratorTool"/>
+ <Tool Name="VCWebServiceProxyGeneratorTool"/>
+ <Tool Name="VCMIDLTool"/>
+ <Tool Name="VCCLCompilerTool" ExecutionBucket="7" Optimization="2" AdditionalIncludeDirectories="..\..\..\src" PreprocessorDefinitions="NDEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES);WINCE;_LIB;$(ARCHFAM);$(_ARCHFAM_);_UNICODE;UNICODE" RuntimeLibrary="0" UsePrecompiledHeader="0" WarningLevel="3" DebugInformationFormat="3"/>
+ <Tool Name="VCManagedResourceCompilerTool"/>
+ <Tool Name="VCResourceCompilerTool" PreprocessorDefinitions="NDEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES)" Culture="1033" AdditionalIncludeDirectories="$(IntDir)"/>
+ <Tool Name="VCPreLinkEventTool"/>
+ <Tool Name="VCLibrarianTool" AdditionalOptions=" /subsystem:windowsce,4.20 /machine:ARM" OutputFile="$(OutDir)/projce.lib"/>
+ <Tool Name="VCALinkTool"/>
+ <Tool Name="VCXDCMakeTool"/>
+ <Tool Name="VCBscMakeTool"/>
+ <Tool Name="VCCodeSignTool"/>
+ <Tool Name="VCPostBuildEventTool"/>
+ <DeploymentTool ForceDirty="-1" RemoteDirectory="" RegisterOutput="0" AdditionalFiles=""/>
+ <DebuggerTool/>
+ </Configuration>
+ <Configuration Name="Release|Windows Mobile 5.0 Pocket PC SDK (ARMV4I)" OutputDirectory="$(PlatformName)\$(ConfigurationName)" IntermediateDirectory="$(PlatformName)\$(ConfigurationName)" ConfigurationType="4" InheritedPropertySheets="..\projce_common.vsprops" CharacterSet="1">
+ <Tool Name="VCPreBuildEventTool"/>
+ <Tool Name="VCCustomBuildTool"/>
+ <Tool Name="VCXMLDataGeneratorTool"/>
+ <Tool Name="VCWebServiceProxyGeneratorTool"/>
+ <Tool Name="VCMIDLTool"/>
+ <Tool Name="VCCLCompilerTool" ExecutionBucket="7" Optimization="2" AdditionalIncludeDirectories="..\..\..\src" PreprocessorDefinitions="NDEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES);WINCE;_LIB;$(ARCHFAM);$(_ARCHFAM_);_UNICODE;UNICODE" RuntimeLibrary="0" UsePrecompiledHeader="0" WarningLevel="3" DebugInformationFormat="3"/>
+ <Tool Name="VCManagedResourceCompilerTool"/>
+ <Tool Name="VCResourceCompilerTool" PreprocessorDefinitions="NDEBUG;_WIN32_WCE=$(CEVER);UNDER_CE;$(PLATFORMDEFINES)" Culture="1033" AdditionalIncludeDirectories="$(IntDir)"/>
+ <Tool Name="VCPreLinkEventTool"/>
+ <Tool Name="VCLibrarianTool" AdditionalOptions=" /subsystem:windowsce,5.01" OutputFile="$(OutDir)/projce.lib"/>
+ <Tool Name="VCALinkTool"/>
+ <Tool Name="VCXDCMakeTool"/>
+ <Tool Name="VCBscMakeTool"/>
+ <Tool Name="VCCodeSignTool"/>
+ <Tool Name="VCPostBuildEventTool"/>
+ <DeploymentTool ForceDirty="-1" RemoteDirectory="" RegisterOutput="0" AdditionalFiles=""/>
+ <DebuggerTool/>
+ </Configuration>
+ </Configurations>
+ <References>
</References>
- <Files>
- <Filter
- Name="proj"
- >
- <Filter
- Name="src"
- >
- <File
- RelativePath="..\..\..\src\aasincos.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\adjlon.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\bch2bps.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\bchgen.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\biveval.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\dmstor.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\emess.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\emess.h"
- >
- </File>
- <File
- RelativePath="..\..\..\src\gen_cheb.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\geocent.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\geocent.h"
- >
- </File>
- <File
- RelativePath="..\..\..\src\geod_for.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\geod_inv.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\geod_set.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\geodesic.h"
- >
- </File>
- <File
- RelativePath="..\..\..\src\hypot.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\jniproj.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\mk_cheby.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\nad_cvt.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\nad_init.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\nad_intr.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\nad_list.h"
- >
- </File>
- <File
- RelativePath="..\..\..\src\org_proj4_Projections.h"
- >
- </File>
- <File
- RelativePath="..\..\..\src\p_series.c"
- >
- </File>
- <File
- RelativePath="..\..\..\src\PJ_aea.c"
- >
+ <Files>
+ <Filter Name="proj">
+ <Filter Name="src">
+ <File RelativePath="..\..\..\src\aasincos.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_aeqd.c"
- >
+ <File RelativePath="..\..\..\src\adjlon.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_airy.c"
- >
+ <File RelativePath="..\..\..\src\bch2bps.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_aitoff.c"
- >
+ <File RelativePath="..\..\..\src\bchgen.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_apply_gridshift.c"
- >
+ <File RelativePath="..\..\..\src\biveval.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_august.c"
- >
+ <File RelativePath="..\..\..\src\dmstor.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_auth.c"
- >
+ <File RelativePath="..\..\..\src\emess.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_bacon.c"
- >
+ <File RelativePath="..\..\..\src\emess.h">
</File>
- <File
- RelativePath="..\..\..\src\PJ_bipc.c"
- >
+ <File RelativePath="..\..\..\src\gen_cheb.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_boggs.c"
- >
+ <File RelativePath="..\..\..\src\geocent.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_bonne.c"
- >
+ <File RelativePath="..\..\..\src\geocent.h">
</File>
- <File
- RelativePath="..\..\..\src\PJ_cass.c"
- >
+ <File RelativePath="..\..\..\src\geod_for.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_cc.c"
- >
+ <File RelativePath="..\..\..\src\geod_inv.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_cea.c"
- >
+ <File RelativePath="..\..\..\src\geod_set.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_chamb.c"
- >
+ <File RelativePath="..\..\..\src\geodesic.h">
</File>
- <File
- RelativePath="..\..\..\src\PJ_collg.c"
- >
+ <File RelativePath="..\..\..\src\hypot.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_crast.c"
- >
+ <File RelativePath="..\..\..\src\jniproj.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_datum_set.c"
- >
+ <File RelativePath="..\..\..\src\mk_cheby.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_datums.c"
- >
+ <File RelativePath="..\..\..\src\nad_cvt.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_denoy.c"
- >
+ <File RelativePath="..\..\..\src\nad_init.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_deriv.c"
- >
+ <File RelativePath="..\..\..\src\nad_intr.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_eck1.c"
- >
+ <File RelativePath="..\..\..\src\nad_list.h">
</File>
- <File
- RelativePath="..\..\..\src\PJ_eck2.c"
- >
+ <File RelativePath="..\..\..\src\org_proj4_Projections.h">
</File>
- <File
- RelativePath="..\..\..\src\PJ_eck3.c"
- >
+ <File RelativePath="..\..\..\src\p_series.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_eck4.c"
- >
+ <File RelativePath="..\..\..\src\PJ_aea.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_eck5.c"
- >
+ <File RelativePath="..\..\..\src\PJ_aeqd.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_ell_set.c"
- >
+ <File RelativePath="..\..\..\src\PJ_airy.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_ellps.c"
- >
+ <File RelativePath="..\..\..\src\PJ_aitoff.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_eqc.c"
- >
+ <File RelativePath="..\..\..\src\pj_apply_gridshift.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_eqdc.c"
- >
+ <File RelativePath="..\..\..\src\PJ_august.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_errno.c"
- >
+ <File RelativePath="..\..\..\src\pj_auth.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_factors.c"
- >
+ <File RelativePath="..\..\..\src\PJ_bacon.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_fahey.c"
- >
+ <File RelativePath="..\..\..\src\PJ_bipc.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_fouc_s.c"
- >
+ <File RelativePath="..\..\..\src\PJ_boggs.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_fwd.c"
- >
+ <File RelativePath="..\..\..\src\PJ_bonne.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_gall.c"
- >
+ <File RelativePath="..\..\..\src\PJ_cass.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_gauss.c"
- >
+ <File RelativePath="..\..\..\src\PJ_cc.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_geocent.c"
- >
+ <File RelativePath="..\..\..\src\PJ_cea.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_geos.c"
- >
+ <File RelativePath="..\..\..\src\PJ_chamb.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_gins8.c"
- >
+ <File RelativePath="..\..\..\src\PJ_collg.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_gn_sinu.c"
- >
+ <File RelativePath="..\..\..\src\PJ_crast.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_gnom.c"
- >
+ <File RelativePath="..\..\..\src\pj_datum_set.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_goode.c"
- >
+ <File RelativePath="..\..\..\src\pj_datums.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_gridinfo.c"
- >
+ <File RelativePath="..\..\..\src\PJ_denoy.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_gridlist.c"
- >
+ <File RelativePath="..\..\..\src\pj_deriv.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_hammer.c"
- >
+ <File RelativePath="..\..\..\src\PJ_eck1.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_hatano.c"
- >
+ <File RelativePath="..\..\..\src\PJ_eck2.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_imw_p.c"
- >
+ <File RelativePath="..\..\..\src\PJ_eck3.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_init.c"
- >
+ <File RelativePath="..\..\..\src\PJ_eck4.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_inv.c"
- >
+ <File RelativePath="..\..\..\src\PJ_eck5.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_krovak.c"
- >
+ <File RelativePath="..\..\..\src\pj_ell_set.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_labrd.c"
- >
+ <File RelativePath="..\..\..\src\pj_ellps.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_laea.c"
- >
+ <File RelativePath="..\..\..\src\PJ_eqc.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_lagrng.c"
- >
+ <File RelativePath="..\..\..\src\PJ_eqdc.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_larr.c"
- >
+ <File RelativePath="..\..\..\src\pj_errno.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_lask.c"
- >
+ <File RelativePath="..\..\..\src\pj_factors.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_latlong.c"
- >
+ <File RelativePath="..\..\..\src\PJ_fahey.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_lcc.c"
- >
+ <File RelativePath="..\..\..\src\PJ_fouc_s.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_lcca.c"
- >
+ <File RelativePath="..\..\..\src\pj_fwd.c">
+ </File>
+ <File RelativePath="..\..\..\src\pj_fwd3d.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_gall.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_list.c"
- >
+ <File RelativePath="..\..\..\src\pj_gauss.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_list.h"
- >
+ <File RelativePath="..\..\..\src\pj_geocent.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_loxim.c"
- >
+ <File RelativePath="..\..\..\src\PJ_geos.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_lsat.c"
- >
+ <File RelativePath="..\..\..\src\PJ_gins8.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_malloc.c"
- >
+ <File RelativePath="..\..\..\src\PJ_gn_sinu.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_mbt_fps.c"
- >
+ <File RelativePath="..\..\..\src\PJ_gnom.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_mbtfpp.c"
- >
+ <File RelativePath="..\..\..\src\PJ_goode.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_mbtfpq.c"
- >
+ <File RelativePath="..\..\..\src\pj_gridinfo.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_merc.c"
- >
+ <File RelativePath="..\..\..\src\pj_gridlist.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_mill.c"
- >
+ <File RelativePath="..\..\..\src\PJ_hammer.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_mlfn.c"
- >
+ <File RelativePath="..\..\..\src\PJ_hatano.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_mod_ster.c"
- >
+ <File RelativePath="..\..\..\src\PJ_imw_p.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_moll.c"
- >
+ <File RelativePath="..\..\..\src\pj_init.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_mpoly.c"
- >
+ <File RelativePath="..\..\..\src\pj_inv.c">
+ </File>
+ <File RelativePath="..\..\..\src\pj_inv3d.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_krovak.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_msfn.c"
- >
+ <File RelativePath="..\..\..\src\PJ_labrd.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_nell.c"
- >
+ <File RelativePath="..\..\..\src\PJ_laea.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_nell_h.c"
- >
+ <File RelativePath="..\..\..\src\PJ_lagrng.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_nocol.c"
- >
+ <File RelativePath="..\..\..\src\PJ_larr.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_nsper.c"
- >
+ <File RelativePath="..\..\..\src\PJ_lask.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_nzmg.c"
- >
+ <File RelativePath="..\..\..\src\pj_latlong.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_ob_tran.c"
- >
+ <File RelativePath="..\..\..\src\PJ_lcc.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_ocea.c"
- >
+ <File RelativePath="..\..\..\src\PJ_lcca.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_oea.c"
- >
+ <File RelativePath="..\..\..\src\pj_list.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_omerc.c"
- >
+ <File RelativePath="..\..\..\src\pj_list.h">
</File>
- <File
- RelativePath="..\..\..\src\pj_open_lib.c"
- >
+ <File RelativePath="..\..\..\src\PJ_loxim.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_ortho.c"
- >
+ <File RelativePath="..\..\..\src\PJ_lsat.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_param.c"
- >
+ <File RelativePath="..\..\..\src\pj_malloc.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_phi2.c"
- >
+ <File RelativePath="..\..\..\src\PJ_mbt_fps.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_poly.c"
- >
+ <File RelativePath="..\..\..\src\PJ_mbtfpp.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_pr_list.c"
- >
+ <File RelativePath="..\..\..\src\PJ_mbtfpq.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_putp2.c"
- >
+ <File RelativePath="..\..\..\src\PJ_merc.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_putp3.c"
- >
+ <File RelativePath="..\..\..\src\PJ_mill.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_putp4p.c"
- >
+ <File RelativePath="..\..\..\src\pj_mlfn.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_putp5.c"
- >
+ <File RelativePath="..\..\..\src\PJ_mod_ster.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_putp6.c"
- >
+ <File RelativePath="..\..\..\src\PJ_moll.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_qsfn.c"
- >
+ <File RelativePath="..\..\..\src\PJ_mpoly.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_release.c"
- >
+ <File RelativePath="..\..\..\src\pj_msfn.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_robin.c"
- >
+ <File RelativePath="..\..\..\src\PJ_nell.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_rpoly.c"
- >
+ <File RelativePath="..\..\..\src\PJ_nell_h.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_sconics.c"
- >
+ <File RelativePath="..\..\..\src\PJ_nocol.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_somerc.c"
- >
+ <File RelativePath="..\..\..\src\PJ_nsper.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_stere.c"
- >
+ <File RelativePath="..\..\..\src\PJ_nzmg.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_sterea.c"
- >
+ <File RelativePath="..\..\..\src\PJ_ob_tran.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_strerrno.c"
- >
+ <File RelativePath="..\..\..\src\PJ_ocea.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_sts.c"
- >
+ <File RelativePath="..\..\..\src\PJ_oea.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_tcc.c"
- >
+ <File RelativePath="..\..\..\src\PJ_omerc.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_tcea.c"
- >
+ <File RelativePath="..\..\..\src\pj_open_lib.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_tmerc.c"
- >
+ <File RelativePath="..\..\..\src\PJ_ortho.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_tpeqd.c"
- >
+ <File RelativePath="..\..\..\src\pj_param.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_transform.c"
- >
+ <File RelativePath="..\..\..\src\pj_phi2.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_tsfn.c"
- >
+ <File RelativePath="..\..\..\src\PJ_poly.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_units.c"
- >
+ <File RelativePath="..\..\..\src\pj_pr_list.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_urm5.c"
- >
+ <File RelativePath="..\..\..\src\PJ_putp2.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_urmfps.c"
- >
+ <File RelativePath="..\..\..\src\PJ_putp3.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_utils.c"
- >
+ <File RelativePath="..\..\..\src\PJ_putp4p.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_vandg.c"
- >
+ <File RelativePath="..\..\..\src\PJ_putp5.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_vandg2.c"
- >
+ <File RelativePath="..\..\..\src\PJ_putp6.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_vandg4.c"
- >
+ <File RelativePath="..\..\..\src\pj_qsfn.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_wag2.c"
- >
+ <File RelativePath="..\..\..\src\pj_release.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_wag3.c"
- >
+ <File RelativePath="..\..\..\src\PJ_robin.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_wag7.c"
- >
+ <File RelativePath="..\..\..\src\PJ_rpoly.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_sch.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_sconics.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_wink1.c"
- >
+ <File RelativePath="..\..\..\src\PJ_somerc.c">
</File>
- <File
- RelativePath="..\..\..\src\PJ_wink2.c"
- >
+ <File RelativePath="..\..\..\src\PJ_stere.c">
</File>
- <File
- RelativePath="..\..\..\src\pj_zpoly1.c"
- >
+ <File RelativePath="..\..\..\src\PJ_sterea.c">
</File>
- <File
- RelativePath="..\..\..\src\proj_api.h"
- >
+ <File RelativePath="..\..\..\src\pj_strerrno.c">
</File>
- <File
- RelativePath="..\..\..\src\proj_config.h"
- >
+ <File RelativePath="..\..\..\src\PJ_sts.c">
</File>
- <File
- RelativePath="..\..\..\src\proj_mdist.c"
- >
+ <File RelativePath="..\..\..\src\PJ_tcc.c">
</File>
- <File
- RelativePath="..\..\..\src\proj_rouss.c"
- >
+ <File RelativePath="..\..\..\src\PJ_tcea.c">
</File>
- <File
- RelativePath="..\..\..\src\projects.h"
- >
+ <File RelativePath="..\..\..\src\PJ_tmerc.c">
</File>
- <File
- RelativePath="..\..\..\src\rtodms.c"
- >
+ <File RelativePath="..\..\..\src\PJ_tpeqd.c">
</File>
- <File
- RelativePath="..\..\..\src\vector1.c"
- >
+ <File RelativePath="..\..\..\src\pj_transform.c">
</File>
- </Filter>
- </Filter>
- </Files>
- <Globals>
+ <File RelativePath="..\..\..\src\pj_tsfn.c">
+ </File>
+ <File RelativePath="..\..\..\src\pj_units.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_urm5.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_urmfps.c">
+ </File>
+ <File RelativePath="..\..\..\src\pj_utils.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_vandg.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_vandg2.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_vandg4.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_wag2.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_wag3.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_wag7.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_wink1.c">
+ </File>
+ <File RelativePath="..\..\..\src\PJ_wink2.c">
+ </File>
+ <File RelativePath="..\..\..\src\pj_zpoly1.c">
+ </File>
+ <File RelativePath="..\..\..\src\proj_api.h">
+ </File>
+ <File RelativePath="..\..\..\src\proj_config.h">
+ </File>
+ <File RelativePath="..\..\..\src\proj_mdist.c">
+ </File>
+ <File RelativePath="..\..\..\src\proj_rouss.c">
+ </File>
+ <File RelativePath="..\..\..\src\projects.h">
+ </File>
+ <File RelativePath="..\..\..\src\rtodms.c">
+ </File>
+ <File RelativePath="..\..\..\src\vector1.c">
+ </File>
+ </Filter>
+ </Filter>
+ </Files>
+ <Globals>
</Globals>
</VisualStudioProject>