From 3197cca5efaf60a38bd353fa50f6b5eb808b87b1 Mon Sep 17 00:00:00 2001
From: Johannes Hofmann <Johannes.Hofmann@gmx.de>
Date: Sun, 17 Dec 2006 12:26:18 +0100
Subject: remove ProjectionTangential

---
 README                       |   2 +-
 configure.ac                 |   4 -
 src/Makefile.am              |   2 -
 src/Panorama.cxx             |   1 -
 src/ProjectionTangential.H   |  29 ----
 src/ProjectionTangential.cxx | 306 -------------------------------------------
 6 files changed, 1 insertion(+), 343 deletions(-)
 delete mode 100644 src/ProjectionTangential.H
 delete mode 100644 src/ProjectionTangential.cxx

diff --git a/README b/README
index 9a6c469..7a332fc 100644
--- a/README
+++ b/README
@@ -22,7 +22,7 @@ Requirements
 - libtiff (http://www.remotesensing.org/libtiff/)
 - libjpeg (http://www.ijg.org/)
 - exif utility (http://libexif.sourceforge.net/)
-- ccmath library (http://freshmeat.net/projects/ccmath/)
+- GSL - GNU Scientific Library (http://www.gnu.org/software/gsl/)
 - gipfel works on UNIX-like system (e.g. Linux, *BSD and probably others)
 
 
diff --git a/configure.ac b/configure.ac
index 347ff2b..b17376c 100644
--- a/configure.ac
+++ b/configure.ac
@@ -57,10 +57,6 @@ fi
 CXXFLAGS="`$GSLCONFIG --cflags` $CXXFLAGS"
 LIBS="`$GSLCONFIG --libs` $LIBS"
 
-# Check for ccmath
-AC_CHECK_HEADERS([ccmath.h], [], [echo "Error: ccmath.h not found."; exit 1;])
-AC_CHECK_LIB([ccm], [open], [], [echo "Error: ccmath.so not found."; exit 1;])
-
 # Check for libtiff
 AC_CHECK_HEADERS([tiffio.h], [], [echo "Error: tiffio.h not found."; exit 1;])
 AC_CHECK_LIB([tiff], [TIFFOpen], [], [echo "Error: libtiff.so not found."; exit 1;])
diff --git a/src/Makefile.am b/src/Makefile.am
index 1cae9b7..36c5b80 100644
--- a/src/Makefile.am
+++ b/src/Makefile.am
@@ -6,7 +6,6 @@ gipfel_SOURCES = \
 	GipfelWidget.cxx \
 	Panorama.cxx \
 	Projection.cxx \
-	ProjectionTangential.cxx \
 	ProjectionTangentialLSQ.cxx \
 	ProjectionSphaeric.cxx \
 	Hill.cxx \
@@ -24,7 +23,6 @@ noinst_HEADERS = \
 	GipfelWidget.H \
 	Panorama.H \
 	Projection.H \
-	ProjectionTangential.H \
 	ProjectionTangentialLSQ.H \
 	ProjectionSphaeric.H \
 	Hill.H \
diff --git a/src/Panorama.cxx b/src/Panorama.cxx
index 948d2f4..52846de 100644
--- a/src/Panorama.cxx
+++ b/src/Panorama.cxx
@@ -10,7 +10,6 @@
 #include <math.h>
 
 #include "Panorama.H"
-#include "ProjectionTangential.H"
 #include "ProjectionTangentialLSQ.H"
 #include "ProjectionSphaeric.H"
 
diff --git a/src/ProjectionTangential.H b/src/ProjectionTangential.H
deleted file mode 100644
index 6734e88..0000000
--- a/src/ProjectionTangential.H
+++ /dev/null
@@ -1,29 +0,0 @@
-//
-// Copyright 2006 Johannes Hofmann <Johannes.Hofmann@gmx.de>
-//
-// This software may be used and distributed according to the terms
-// of the GNU General Public License, incorporated herein by reference.
-
-#ifndef PROJECTIONTANGENTIAL_H
-#define PROJECTIONTANGENTIAL_H
-
-#include "Hill.H"
-#include "Projection.H"
-
-class ProjectionTangential : public Projection {
-	private:
-		double comp_center_angle(double alph_a, double alph_b, double d1, double d2);
-
-		double comp_scale(double alph_a, double alph_b, double d1, double d2);
-
-		double angle_dist(double a1, double a2);
-
-		int optimize(const Hill *m1, const Hill *m2, ViewParams *parms);
-
-	public:
-		void get_coordinates(double a_view, double a_nick, const ViewParams *parms,
-			double *x, double *y);
-
-		int comp_params(const Hills *h, ViewParams *parms);
-};
-#endif
diff --git a/src/ProjectionTangential.cxx b/src/ProjectionTangential.cxx
deleted file mode 100644
index 16488ad..0000000
--- a/src/ProjectionTangential.cxx
+++ /dev/null
@@ -1,306 +0,0 @@
-//
-// Copyright 2006 Johannes Hofmann <Johannes.Hofmann@gmx.de>
-//
-// This software may be used and distributed according to the terms
-// of the GNU General Public License, incorporated herein by reference.
-
-#include <stdio.h>
-#include <stdlib.h>
-#include <string.h>
-#include <math.h>
-extern "C" {
-#include <ccmath.h>
-}
-
-#include "ProjectionTangential.H"
-
-static int opt_step(double *tan_nick_view, 
-	double *tan_dir_view,
-	double *n_scale,
-	double tan_dir_m1,
-	double tan_nick_m1,
-	double tan_dir_m2,
-	double tan_nick_m2,
-	double d_m1_2, double d_m2_2, double d_m1_m2_2);
-
-static double
-comp_tilt(double tan_nick_view, double tan_dir_view, double n_scale,
-	double tan_nick_m, double tan_dir_m,
-	double x, double y, double pi_d);
-
-int
-ProjectionTangential::comp_params(const Hills *h, ViewParams *parms) {
-	const Hill *tmp, *m1, *m2;
-	double a_center_tmp, scale_tmp, a_nick_tmp;
-
-	if (h->get_num() != 2) {
-		return 1;
-	}
-
-	m1 = h->get(0);
-	m2 = h->get(1);
-
-
-	scale_tmp = comp_scale(m1->alph, m2->alph, m1->x, m2->x);
-	if (isnan(scale_tmp) || scale_tmp < 100.0) {
-		// try again with mountains swapped
-		tmp = m1;
-		m1 = m2;
-		m2 = tmp;
-		scale_tmp = comp_scale(m1->alph, m2->alph, m1->x, m2->x);
-	}
-
-	a_center_tmp = comp_center_angle(m1->alph, m2->alph, m1->x, m2->x);
-	a_nick_tmp   = atan ((m1->y + tan(m1->a_nick) * parms->scale) / 
-		(parms->scale - m1->y * tan(m1->a_nick)));
-
-	if (isnan(a_center_tmp) || isnan(scale_tmp) ||
-		scale_tmp < 100.0 || isnan(a_nick_tmp)) {
-		return 1;
-	} else {
-
-		parms->a_center = a_center_tmp;
-		parms->scale    = scale_tmp;
-		parms->a_nick   = a_nick_tmp;
-
-		optimize(m1, m2, parms);
-
-		return 0;
-	}
-}
-
-double 
-ProjectionTangential::angle_dist(double a1, double a2) {
-	double ret;
-
-	a1 = fmod(a1, 2.0 * pi_d); 
-	if (a1 < 0.0) {
-		a1 = a1 + 2.0 * pi_d;
-	}
-	a2 = fmod(a2, 2.0 * pi_d); 
-	if (a2 < 0.0) {
-		a2 = a2 + 2.0 * pi_d;
-	}
-
-	ret = fabs(a1 - a2);
-	if (ret > pi_d) {
-		ret = 2.0 * pi_d - ret;
-	} 
-
-	return ret;
-}
-
-int
-ProjectionTangential::optimize(const Hill *m1, const Hill *m2, ViewParams *parms) {
-	int i;
-	double tan_nick_view, tan_dir_view, n_scale;
-	double tan_nick_m1, tan_dir_m1;
-	double tan_nick_m2, tan_dir_m2;
-	double d_m1_2, d_m2_2, d_m1_m2_2;
-
-	d_m1_2 = pow(m1->x, 2.0) + pow(m1->y, 2.0);
-	d_m2_2 = pow(m2->x, 2.0) + pow(m2->y, 2.0);
-	d_m1_m2_2 = pow(m1->x - m2->x, 2.0) + pow(m1->y - m2->y, 2.0);
-
-	tan_nick_view = tan(parms->a_nick);
-	tan_dir_view = tan(parms->a_center);
-	n_scale = parms->scale;
-	tan_dir_m1 = tan(m1->alph);
-	tan_nick_m1 = tan(m1->a_nick);
-	tan_dir_m2 = tan(m2->alph);
-	tan_nick_m2 = tan(m2->a_nick);
-
-	for (i=0; i<5; i++) {
-		opt_step(&tan_nick_view, &tan_dir_view, &n_scale, 
-			tan_dir_m1, tan_nick_m1, tan_dir_m2, tan_nick_m2,
-			d_m1_2, d_m2_2, d_m1_m2_2);
-	}
-
-	if (isnan(tan_dir_view) || isnan(tan_nick_view) || isnan(n_scale)) {
-		fprintf(stderr, "No solution found.\n");
-		return 1;
-	}
-
-	parms->a_center = atan(tan_dir_view);
-	parms->a_nick = atan(tan_nick_view);
-
-	if (parms->a_center > 2.0 * pi_d) {
-		parms->a_center = parms->a_center - 2.0 * pi_d;
-	} else if (parms->a_center < 0.0) {
-		parms->a_center = parms->a_center + 2.0 * pi_d;
-	}
-
-	// atan(tan_dir_view) is not the only possible solution.
-	// Choose the one which is close to m1->alph.
-	if (angle_dist(parms->a_center, m1->alph) > pi_d/2.0) {
-		parms->a_center = parms->a_center + pi_d;
-	}
-
-	parms->scale = n_scale;
-
-	// use the point with greater distance from center for tilt computation 
-	if (d_m1_2 > d_m2_2) {
-		parms->a_tilt = comp_tilt(tan_nick_view, tan_dir_view, n_scale, 
-			tan_nick_m1, tan_dir_m1,
-			(double) m1->x, (double) m1->y, pi_d);
-	} else {
-		parms->a_tilt = comp_tilt(tan_nick_view, tan_dir_view, n_scale, 
-			tan_nick_m2, tan_dir_m2,
-			(double) m2->x, (double) m2->y, pi_d);
-	}
-
-	return 0;
-}
-
-void 
-ProjectionTangential::get_coordinates(double a_view, double a_nick,
-	const ViewParams *parms, double *x, double *y) {
-	double x_tmp, y_tmp;
-
-	x_tmp = tan(a_view) * parms->scale;
-	y_tmp = - (tan(a_nick - parms->a_nick) * parms->scale);
-
-	// rotate by a_tilt;
-	*x = x_tmp * cos(parms->a_tilt) - y_tmp * sin(parms->a_tilt);
-	*y = x_tmp * sin(parms->a_tilt) + y_tmp * cos(parms->a_tilt);
-}
-
-double
-ProjectionTangential::comp_center_angle(double a1, double a2, double d1, double d2) {
-	double sign1 = 1.0;
-	double tan_acenter, tan_a1, tan_a2, a_center;
-
-	tan_a1 = tan(a1);
-	tan_a2 = tan(a2);
-
-	tan_acenter = (((pow(((pow((1.0 + (tan_a1 * tan_a2)), 2.0) * ((d1 * d1) + (d2 * d2))) + (2.0 * d1 * d2 * ((2.0 * ((tan_a2 * tan_a1) - (tan_a2 * tan_a2))) - ((tan_a1 * tan_a1) * (2.0 + (tan_a2 * tan_a2))) - 1.0))), (1.0 / 2.0)) * sign1) + ((1.0 - (tan_a1 * tan_a2)) * (d1 - d2))) / (2.0 * ((d2 * tan_a2) - (d1 * tan_a1))));
-
-	a_center = atan(tan_acenter);
-
-	if (a_center > 2.0 * pi_d) {
-		a_center = a_center - 2.0 * pi_d;
-	} else if (a_center < 0.0) {
-		a_center = a_center + 2.0 * pi_d;
-	}
-
-	// atan(tan_dir_view) is not the only possible solution.
-	// Choose the one which is close to m1->alph.
-	if (fabs(a_center - a1) > pi_d/2.0) {
-		a_center = a_center + pi_d;
-	}
-
-	return a_center; 
-}
-
-double
-ProjectionTangential::comp_scale(double a1, double a2, double d1, double d2) {
-	double sign1 = 1.0;
-	double sc, tan_a1, tan_a2;
-
-	tan_a1 = tan(a1);
-	tan_a2 = tan(a2);
-
-	sc = ((((1.0 + (tan_a1 * tan_a2)) * (d1 - d2)) - (sign1 * pow((((1.0 + pow((tan_a1 * tan_a2), 2.0)) * ((d1 * d1) + (d2 * d2))) + (2.0 * ((tan_a1 * tan_a2 * pow((d1 + d2), 2.0)) - (d1 * d2 * (((tan_a1 * tan_a1) * (2.0 + (tan_a2 * tan_a2))) + 1.0 + (2.0 * (tan_a2 * tan_a2))))))), (1.0 / 2.0)))) / (2.0 * (tan_a1 - tan_a2)));
-
-	return sc;
-}
-
-static int
-get_matrix(double m[], 
-	double tan_nick_view, double tan_dir_view, double n_scale,
-	double tan_dir_m1, double tan_nick_m1,
-	double tan_dir_m2, double tan_nick_m2) {
-
-	m[0] = pow(n_scale,2.0)*(1.0/pow((tan_nick_m1*tan_nick_view + 1.0),2.0)*(2.0*tan_nick_m1 - 2.0 * tan_nick_view) + 2.0*tan_nick_m1*pow((tan_nick_m1 - tan_nick_view), 2.0)/pow((tan_nick_m1*tan_nick_view + 1.0), 3.0));
-
-	m[1] = pow(n_scale, 2.0) *(1.0/pow((tan_dir_m1*tan_dir_view + 1.0), 2.0) * (2.0*tan_dir_m1 - 2.0*tan_dir_view) + 2.0*tan_dir_m1*pow((tan_dir_m1 - tan_dir_view),2.0) / pow((tan_dir_m1*tan_dir_view + 1.0), 3.0));
-
-	m[2] = -2.0*n_scale*(pow((tan_dir_m1 - tan_dir_view), 2.0)/pow((tan_dir_m1*tan_dir_view + 1.0), 2.0) + pow((tan_nick_m1 - tan_nick_view), 2.0)/pow((tan_nick_m1*tan_nick_view + 1.0), 2.0));
-
-	m[3] = pow(n_scale, 2.0)*(1.0/pow((tan_nick_m2*tan_nick_view + 1.0), 2.0)*(2.0*tan_nick_m2 - 2.0*tan_nick_view) + 2.0*tan_nick_m2*pow((tan_nick_m2 - tan_nick_view), 2.0)/pow((tan_nick_m2*tan_nick_view + 1.0), 3.0));
-
-	m[4] = pow(n_scale, 2.0)*(1.0/pow((tan_dir_m2*tan_dir_view + 1.0), 2.0)*(2.0*tan_dir_m2 - 2.0*tan_dir_view) + 2.0*tan_dir_m2*pow((tan_dir_m2 - tan_dir_view), 2.0)/pow((tan_dir_m2*tan_dir_view + 1.0), 3.0));
-
-	m[5] = -2.0*n_scale*(pow((tan_dir_m2 - tan_dir_view), 2.0)/pow((tan_dir_m2*tan_dir_view + 1.0), 2.0) + pow((tan_nick_m2 - tan_nick_view), 2.0)/pow((tan_nick_m2*tan_nick_view + 1.0), 2.0));
-
-	m[6] = 2.0*(n_scale*(tan_nick_m1 - tan_nick_view)/(tan_nick_m1*tan_nick_view + 1.0) - n_scale*(tan_nick_m2 - tan_nick_view)/(tan_nick_m2*tan_nick_view + 1.0))*(n_scale/(tan_nick_m1*tan_nick_view + 1.0) - n_scale/(tan_nick_m2*tan_nick_view + 1.0) + tan_nick_m1*n_scale*(tan_nick_m1 - tan_nick_view)/pow((tan_nick_m1*tan_nick_view + 1.0), 2.0) - tan_nick_m2*n_scale*(tan_nick_m2 - tan_nick_view)/pow((tan_nick_m2*tan_nick_view + 1.0),2.0));
-
-	m[7] = 2.0*(n_scale*(tan_dir_m1 - tan_dir_view)/(tan_dir_m1*tan_dir_view + 1.0) - n_scale*(tan_dir_m2 - tan_dir_view)/(tan_dir_m2*tan_dir_view + 1.0))*(n_scale/(tan_dir_m1*tan_dir_view + 1.0) - n_scale/(tan_dir_m2*tan_dir_view + 1.0) + tan_dir_m1*n_scale*(tan_dir_m1 - tan_dir_view)/pow((tan_dir_m1*tan_dir_view + 1.0), 2.0) - tan_dir_m2*n_scale*(tan_dir_m2 - tan_dir_view)/pow((tan_dir_m2*tan_dir_view + 1.0), 2.0));
-
-	m[8] = - 2.0*(n_scale*(tan_dir_m1 - tan_dir_view)/(tan_dir_m1*tan_dir_view + 1.0) - n_scale*(tan_dir_m2 - tan_dir_view)/(tan_dir_m2*tan_dir_view + 1.0))*((tan_dir_m1 - tan_dir_view)/(tan_dir_m1*tan_dir_view + 1.0) - (tan_dir_m2 - tan_dir_view)/(tan_dir_m2*tan_dir_view + 1.0)) - 2.0*(n_scale*(tan_nick_m1 - tan_nick_view)/(tan_nick_m1*tan_nick_view + 1.0) - n_scale*(tan_nick_m2 - tan_nick_view)/(tan_nick_m2*tan_nick_view + 1.0))*((tan_nick_m1 - tan_nick_view)/(tan_nick_m1*tan_nick_view + 1.0) - (tan_nick_m2 - tan_nick_view)/(tan_nick_m2*tan_nick_view + 1.0));
-
-	return 0;
-}
-
-static int opt_step(double *tan_nick_view, 
-	double *tan_dir_view,
-	double *n_scale,
-	double tan_dir_m1,
-	double tan_nick_m1,
-	double tan_dir_m2,
-	double tan_nick_m2,
-	double d_m1_2, double d_m2_2, double d_m1_m2_2) {
-	double a[9];
-	double b[3];
-	double a_x0[3], f_x0 [3], x0[3];
-	int ret;
-
-	get_matrix(a, *tan_nick_view, *tan_dir_view, *n_scale, 
-		tan_dir_m1, tan_nick_m1, tan_dir_m2, tan_nick_m2);
-
-	f_x0[0] = d_m1_2 - (pow((*tan_nick_view-tan_nick_m1),2.0)/pow((tan_nick_m1**tan_nick_view+1), 2.0)+pow((*tan_dir_view-tan_dir_m1),2.0)/pow((tan_dir_m1**tan_dir_view+1),2.0))*pow(*n_scale, 2.0);
-
-	f_x0[1] = d_m2_2 - (pow((*tan_nick_view-tan_nick_m2),2.0)/pow((tan_nick_m2**tan_nick_view+1),2.0)+pow((*tan_dir_view-tan_dir_m2),2.0)/pow((tan_dir_m2**tan_dir_view+1),2.0))*pow(*n_scale, 2.0);
-
-	f_x0[2] = d_m1_m2_2 - (pow((- (((*tan_dir_view - tan_dir_m1) * *n_scale) / (tan_dir_m1 * *tan_dir_view + 1.0)) + (((*tan_dir_view - tan_dir_m2) * *n_scale) / (tan_dir_m2 * *tan_dir_view + 1))), 2.0) + pow((- (((*tan_nick_view - tan_nick_m1) * *n_scale) / (tan_nick_m1 * *tan_nick_view + 1)) + ((*tan_nick_view - tan_nick_m2) * *n_scale) / (tan_nick_m2 * *tan_nick_view + 1)), 2.0));
-
-	x0[0] = *tan_nick_view;
-	x0[1] = *tan_dir_view;
-	x0[2] = *n_scale;
-
-	rmmult(a_x0, a, x0, 3, 3, 1);
-
-	b[0] = a_x0[0] - f_x0[0];
-	b[1] = a_x0[1] - f_x0[1];
-	b[2] = a_x0[2] - f_x0[2];
-
-	ret = solv(a, b, 3);
-
-	*tan_nick_view = b[0];
-	*tan_dir_view  = b[1];
-	*n_scale       = b[2];
-
-	return 0;
-}
-
-
-static double
-comp_tilt(double tan_nick_view, double tan_dir_view, double n_scale,
-	double tan_nick_m, double tan_dir_m,
-	double x, double y, double pi_d) {
-	double y_tmp, x_tmp, sin_a_tilt1, sin_a_tilt2, sin_a_tilt, res;
-
-	y_tmp = - (((tan_nick_view - tan_nick_m) * n_scale) / 
-		(tan_nick_m * tan_nick_view + 1));
-	x_tmp = - (((tan_dir_view - tan_dir_m) * n_scale) / 
-		(tan_dir_m * tan_dir_view + 1));
-
-
-	sin_a_tilt1 = - (y * - pow(x*x + y*y - y_tmp*y_tmp, 0.5) - x * y_tmp) /
-		(x*x + y*y);
-
-	sin_a_tilt2 = - (y * pow(x*x + y*y - y_tmp*y_tmp, 0.5) - x * y_tmp) / 
-		(x*x + y*y);
-
-	sin_a_tilt = fabs(sin_a_tilt1) < fabs(sin_a_tilt2)?sin_a_tilt1:sin_a_tilt2;
-
-	res = asin(sin_a_tilt);
-
-	if (res > pi_d / 4.0) {
-		res = res - pi_d / 2.0;
-	} else if (res < -pi_d / 4.0) {
-		res = res + pi_d / 2.0;
-	}
-
-	return res;
-}
-- 
cgit v1.2.3