[med-svn] r11160 - trunk/packages/vxl/branches/experimental/debian/patches
Mathieu Malaterre
malat at alioth.debian.org
Fri Jun 1 14:51:20 UTC 2012
Author: malat
Date: 2012-06-01 14:51:20 +0000 (Fri, 01 Jun 2012)
New Revision: 11160
Added:
trunk/packages/vxl/branches/experimental/debian/patches/import_trunk.patch
Modified:
trunk/packages/vxl/branches/experimental/debian/patches/series
trunk/packages/vxl/branches/experimental/debian/patches/vxl.soname.patch
Log:
import diff from trunk
Added: trunk/packages/vxl/branches/experimental/debian/patches/import_trunk.patch
===================================================================
--- trunk/packages/vxl/branches/experimental/debian/patches/import_trunk.patch (rev 0)
+++ trunk/packages/vxl/branches/experimental/debian/patches/import_trunk.patch 2012-06-01 14:51:20 UTC (rev 11160)
@@ -0,0 +1,527 @@
+$ svn di -r34967:34978
+Index: vxl-1.17.0/brl/bseg/boxm/sample/algo/tests/test_sigma_normalizer.cxx
+===================================================================
+--- /dev/null 1970-01-01 00:00:00.000000000 +0000
++++ vxl-1.17.0/brl/bseg/boxm/sample/algo/tests/test_sigma_normalizer.cxx 2012-06-01 16:47:10.085701265 +0200
+@@ -0,0 +1,59 @@
++
++#include <testlib/testlib_test.h>
++#include <vnl/vnl_random.h>
++#include <boxm/sample/algo/boxm_sigma_normalizer.h>
++#include <bsta/bsta_gauss_sf1.h>
++#include <bsta/algo/bsta_fit_gaussian.h>
++
++
++static void test_sigma_normalizer()
++{
++ START("boxm_sigma_normalizer test");
++
++ // generate random sets of samples from a normal distribution and compare sigma estimate to true value
++ {
++ vnl_random rand_gen;
++ unsigned int n_trials = 5000;
++
++ unsigned int n_observations = 6;
++ float true_sigma = 0.5f;
++ float true_mean = 2.5f;
++ float under_estimation_prob = 0.4f;
++ unsigned int under_estimates = 0;
++
++ boxm_sigma_normalizer normalizer(under_estimation_prob);
++
++ for (unsigned int t=0; t<n_trials; ++t) {
++ vcl_vector<float> samples;
++ vcl_vector<float> weights;
++ for (unsigned int n=0; n<n_observations; ++n) {
++ float sample = true_mean + true_sigma*(float)rand_gen.normal();
++ samples.push_back(sample);
++ weights.push_back(1.0f);
++ }
++ // compute the sample mean and variance
++ bsta_gauss_sf1 gauss_model;
++ bsta_fit_gaussian(samples, weights, gauss_model);
++ float normalized_sigma = vcl_sqrt(gauss_model.var()) * normalizer.normalization_factor_int(n_observations);
++ if (normalized_sigma < true_sigma) {
++ ++under_estimates;
++ }
++ }
++ float under_estimate_ratio = (float)under_estimates / n_trials;
++
++ TEST_NEAR("correct ratio of sigma under-estimates", under_estimate_ratio, under_estimation_prob, 0.05);
++ }
++
++ // make sure normalization factor approaches 1 for large sample sizes
++ {
++ boxm_sigma_normalizer sigma_norm(0.10f);
++ float norm_factor_f = sigma_norm.normalization_factor(10000.0f);
++ float norm_factor_i = sigma_norm.normalization_factor_int(10000);
++
++ TEST_NEAR("normalization factor (float) approaches 1 for large N",norm_factor_f, 1.0, 0.1);
++ TEST_NEAR("normalization factor (int) approaches 1 for large N",norm_factor_i, 1.0, 0.1);
++ }
++ return;
++}
++
++TESTMAIN(test_sigma_normalizer);
+Index: vxl-1.17.0/brl/bseg/boxm/sample/algo/tests/test_driver.cxx
+===================================================================
+--- /dev/null 1970-01-01 00:00:00.000000000 +0000
++++ vxl-1.17.0/brl/bseg/boxm/sample/algo/tests/test_driver.cxx 2012-06-01 16:47:10.085701265 +0200
+@@ -0,0 +1,11 @@
++#include <testlib/testlib_register.h>
++
++DECLARE( test_sigma_normalizer );
++
++void register_tests()
++{
++ REGISTER( test_sigma_normalizer );
++}
++
++
++DEFINE_MAIN;
+Index: vxl-1.17.0/brl/bseg/boxm/sample/algo/tests/CMakeLists.txt
+===================================================================
+--- /dev/null 1970-01-01 00:00:00.000000000 +0000
++++ vxl-1.17.0/brl/bseg/boxm/sample/algo/tests/CMakeLists.txt 2012-06-01 16:47:10.085701265 +0200
+@@ -0,0 +1,9 @@
++ADD_EXECUTABLE( boxm_sample_algo_test_all
++ test_driver.cxx
++ test_sigma_normalizer.cxx
++ )
++
++TARGET_LINK_LIBRARIES( boxm_sample_algo_test_all boxm_sample_algo boxm_sample boxm testlib vcl vnl vnl_algo vbl bsta bsta_algo)
++
++ADD_TEST( boxm_sample_test_sigma_normalizer ${EXECUTABLE_OUTPUT_PATH}/boxm_sample_algo_test_all test_sigma_normalizer )
++
+Index: vxl-1.17.0/brl/bseg/boxm/sample/algo/boxm_sigma_normalizer.cxx
+===================================================================
+--- /dev/null 1970-01-01 00:00:00.000000000 +0000
++++ vxl-1.17.0/brl/bseg/boxm/sample/algo/boxm_sigma_normalizer.cxx 2012-06-01 16:47:10.085701265 +0200
+@@ -0,0 +1,103 @@
++#include "boxm_sigma_normalizer.h"
++//:
++// \file
++// \brief A class for adjusting sample standard deviation values such that the probability of underestimation of the true std. dev. is fixed.
++
++#include <vcl_iostream.h>
++
++#include <vnl/vnl_vector_fixed.h>
++#include <vnl/vnl_gamma.h>
++#include <vnl/vnl_least_squares_function.h>
++#include <vnl/algo/vnl_levenberg_marquardt.h>
++
++boxm_sigma_normalizer::boxm_sigma_normalizer(float under_estimation_probability) : unbias_const_(N_PRECOMPUTED_+1, 0.0f)
++{
++ class gammainc_error_fn : public vnl_least_squares_function
++ {
++ public:
++ gammainc_error_fn(unsigned int ndof, float under_estimation_prob) : vnl_least_squares_function(1,1,no_gradient), ndof_(ndof), p_(under_estimation_prob) {}
++
++ virtual void f(vnl_vector<double> const& x, vnl_vector<double>& fx)
++ {
++ // don't allow x to become negative
++ if (x[0] < 0.0f) {
++ fx[0] = x[0] - p_; // so error function is c0 continuous at x=0
++ return;
++ }
++ double cdf_prob = vnl_cum_prob_chi2(ndof_, x[0]);
++ fx[0] = cdf_prob - p_;
++ return;
++ }
++ private:
++ unsigned int ndof_;
++ float p_;
++ };
++
++ // sanity check on probability
++ if (under_estimation_probability < 1e-4) {
++ vcl_cout << "error : boxm_sigma_normalizer : under_estimation_probability " << under_estimation_probability << " too low" << vcl_endl;
++ return;
++ }
++ if (under_estimation_probability > (1 - 1e-4)) {
++ vcl_cout << "error : boxm_sigma_normalizer : under_estimation_probability " << under_estimation_probability << " too high" << vcl_endl;
++ return;
++ }
++
++ // populate array of normalization factors for easy lookup
++ vnl_vector_fixed<double,1> x(1.0);
++
++ for (unsigned int n=2; n<= N_PRECOMPUTED_; ++n) {
++ gammainc_error_fn f(n-1, under_estimation_probability);
++ vnl_levenberg_marquardt minimizer(f);
++ minimizer.set_f_tolerance(1e-8);
++ minimizer.set_x_tolerance(1e-8);
++
++ minimizer.minimize(x);
++ //minimizer.diagnose_outcome();
++ double end_error = minimizer.get_end_error();
++ if (end_error > 1e-3) {
++ vcl_cerr << "error: boxm_sigma_normalizer: levenberg_marquardt final error = " << end_error << '\n';
++ }
++ float unbias_constant = (float)vcl_sqrt((float)(n-1) / x[0]);
++
++ unbias_const_[n] = unbias_constant;
++ }
++ // sigma is undefined for samples sizes of 0 and 1, but we can linearly interpolate to get values anyway
++ unbias_const_[1] = unbias_const_[2] - (unbias_const_[3] - unbias_const_[2]);
++ unbias_const_[0] = unbias_const_[1] - (unbias_const_[2] - unbias_const_[1]);
++}
++
++
++float boxm_sigma_normalizer::normalization_factor(float number_of_observations) const
++{
++ if (number_of_observations <= 1.0f) {
++ return normalization_factor_int((unsigned int)1);
++ }
++
++ // linearly interpolate between integer values
++ float nobs_floor = vcl_floor(number_of_observations);
++ float nobs_ceil = vcl_ceil(number_of_observations);
++ float floor_weight = nobs_ceil - number_of_observations;
++ float norm_factor = (normalization_factor_int((unsigned int)nobs_floor) * floor_weight) + (normalization_factor_int((unsigned int)nobs_ceil) * (1.0f - floor_weight));
++
++ return norm_factor;
++}
++
++
++float boxm_sigma_normalizer::normalization_factor_int(unsigned int number_of_observations) const
++{
++ if (number_of_observations < 2) {
++ return unbias_const_[1];
++ }
++
++ if (number_of_observations <= N_PRECOMPUTED_) {
++ return unbias_const_[number_of_observations];
++ }
++ // else nobs >= N_PRECOMPUTED_
++ // approximate for big n with function a = m /nobs + b
++ static const float m = (unbias_const_[N_PRECOMPUTED_] - unbias_const_[N_PRECOMPUTED_ - 5])/(1.0f/N_PRECOMPUTED_ - 1.0f/(N_PRECOMPUTED_ - 5));
++ static const float b = unbias_const_[N_PRECOMPUTED_] - m*(1.0f/N_PRECOMPUTED_);
++ return m/number_of_observations + b;
++}
++
++
+Index: vxl-1.17.0/brl/bseg/boxm/sample/algo/boxm_sigma_normalizer.h
+===================================================================
+--- /dev/null 1970-01-01 00:00:00.000000000 +0000
++++ vxl-1.17.0/brl/bseg/boxm/sample/algo/boxm_sigma_normalizer.h 2012-06-01 16:47:10.085701265 +0200
+@@ -0,0 +1,39 @@
++// this is brl/bseg/boxm/sample/algo/boxm_sigma_normalizer.h
++#ifndef boxm_sigma_normalizer_h_
++#define boxm_sigma_normalizer_h_
++//:
++// \file
++// \brief A class for adjusting sample standard deviation values such that the probability of underestimation of the true std. dev. is fixed.
++//
++// \author Daniel Crispell
++// \date Feb. 18, 2010
++// \verbatim
++// Modifications
++// <none yet>
++// \endverbatim
++
++#include <vcl_vector.h>
++
++class boxm_sigma_normalizer
++{
++ public:
++ //: create a sigma_normalizer object.
++ boxm_sigma_normalizer(float under_estimation_probability);
++
++ //: compute the normalization factor for a sample distribution computing with N observations
++ // \a sigma_norm = sample_sigma * normalization_factor(N);
++ float normalization_factor(float number_of_observations) const;
++
++ //: compute the normalization factor for a sample distribution computed with N observations
++ // \a sigma_norm = sample_sigma * normalization_factor(N);
++ float normalization_factor_int(unsigned int number_of_observations) const;
++
++ private:
++ // do not allow default constructor - under-estimation param is necessary
++ boxm_sigma_normalizer(){}
++
++ static const unsigned int N_PRECOMPUTED_ = 40;
++ vcl_vector<float> unbias_const_;
++};
++
++#endif
+Index: vxl-1.17.0/brl/bseg/boxm/sample/Templates/boxm_cell_vis_graph_iterator+short.boxm_edge_tangent_sample+float--.cxx
+===================================================================
+--- vxl-1.17.0.orig/brl/bseg/boxm/sample/Templates/boxm_cell_vis_graph_iterator+short.boxm_edge_tangent_sample+float--.cxx 2012-06-01 16:44:20.045703613 +0200
++++ /dev/null 1970-01-01 00:00:00.000000000 +0000
+@@ -1,6 +0,0 @@
+-#include <boxm/basic/boxm_cell_vis_graph_iterator.txx>
+-#include <boct/boct_tree.txx>
+-#include <boxm/sample/boxm_edge_tangent_sample.txx>
+-#include <vgl/io/vgl_io_point_3d.h>
+-
+-BOXM_CELL_VIS_GRAPH_ITERATOR_INSTANTIATE(short,boxm_edge_tangent_sample<float>);
+Index: vxl-1.17.0/brl/bseg/boxm/sample/Templates/boxm_block_vis_graph_iterator+boct_tree+short.boxm_edge_sample+float---.cxx
+===================================================================
+--- vxl-1.17.0.orig/brl/bseg/boxm/sample/Templates/boxm_block_vis_graph_iterator+boct_tree+short.boxm_edge_sample+float---.cxx 2012-06-01 16:44:20.049703613 +0200
++++ /dev/null 1970-01-01 00:00:00.000000000 +0000
+@@ -1,6 +0,0 @@
+-#include <boxm/basic/boxm_block_vis_graph_iterator.txx>
+-#include <boct/boct_tree.txx>
+-#include <boxm/sample/boxm_edge_sample.h>
+-
+-typedef boct_tree<short, boxm_edge_sample<float> > tree_type;
+-BOXM_BLOCK_VIS_GRAPH_ITERATOR_INSTANTIATE(tree_type);
+Index: vxl-1.17.0/brl/bseg/boxm/sample/Templates/boxm_cell_vis_graph_iterator+short.boxm_edge_sample+float--.cxx
+===================================================================
+--- vxl-1.17.0.orig/brl/bseg/boxm/sample/Templates/boxm_cell_vis_graph_iterator+short.boxm_edge_sample+float--.cxx 2012-06-01 16:44:20.049703613 +0200
++++ /dev/null 1970-01-01 00:00:00.000000000 +0000
+@@ -1,7 +0,0 @@
+-#include <boxm/basic/boxm_cell_vis_graph_iterator.txx>
+-#include <boct/boct_tree.txx>
+-#include <boxm/sample/boxm_edge_sample.txx>
+-#include <vgl/io/vgl_io_point_3d.h>
+-
+-BOXM_CELL_VIS_GRAPH_ITERATOR_INSTANTIATE(short,boxm_edge_sample<float>);
+-BOXM_CELL_VIS_GRAPH_ITERATOR_INSTANTIATE(short,boxm_aux_edge_sample<float>);
+Index: vxl-1.17.0/brl/bseg/boxm/sample/Templates/boxm_block_vis_graph_iterator+boct_tree+short.boxm_edge_tangent_sample+float---.cxx
+===================================================================
+--- vxl-1.17.0.orig/brl/bseg/boxm/sample/Templates/boxm_block_vis_graph_iterator+boct_tree+short.boxm_edge_tangent_sample+float---.cxx 2012-06-01 16:44:20.049703613 +0200
++++ /dev/null 1970-01-01 00:00:00.000000000 +0000
+@@ -1,13 +0,0 @@
+-#include <boxm/basic/boxm_block_vis_graph_iterator.txx>
+-#include <boct/boct_tree.txx>
+-#include <boxm/sample/boxm_edge_tangent_sample.h>
+-#include <boxm/sample/boxm_inf_line_sample.h>
+-
+-typedef boct_tree<short, boxm_edge_tangent_sample<float> > tree_type;
+-BOXM_BLOCK_VIS_GRAPH_ITERATOR_INSTANTIATE(tree_type);
+-
+-typedef boct_tree<short, boxm_inf_line_sample<float> > aux_tree_type;
+-BOXM_BLOCK_VIS_GRAPH_ITERATOR_INSTANTIATE(aux_tree_type);
+-
+-typedef boct_tree<short, float > aux_tree_type2;
+-BOXM_BLOCK_VIS_GRAPH_ITERATOR_INSTANTIATE(aux_tree_type2);
+Index: vxl-1.17.0/brl/bseg/boxm/sample/Templates/boxm_cell_vis_graph_iterator+short.boxm_inf_line_sample+float--.cxx
+===================================================================
+--- vxl-1.17.0.orig/brl/bseg/boxm/sample/Templates/boxm_cell_vis_graph_iterator+short.boxm_inf_line_sample+float--.cxx 2012-06-01 16:44:20.049703613 +0200
++++ /dev/null 1970-01-01 00:00:00.000000000 +0000
+@@ -1,6 +0,0 @@
+-#include <boxm/basic/boxm_cell_vis_graph_iterator.txx>
+-#include <boct/boct_tree.txx>
+-#include <boxm/sample/boxm_inf_line_sample.h>
+-#include <vgl/io/vgl_io_point_3d.h>
+-
+-BOXM_CELL_VIS_GRAPH_ITERATOR_INSTANTIATE(short,boxm_inf_line_sample<float>);
+Index: vxl-1.17.0/brl/bseg/boxm/basic/Templates/boxm_block_vis_graph_iterator+boct_tree+short.boxm_edge_sample+float---.cxx
+===================================================================
+--- /dev/null 1970-01-01 00:00:00.000000000 +0000
++++ vxl-1.17.0/brl/bseg/boxm/basic/Templates/boxm_block_vis_graph_iterator+boct_tree+short.boxm_edge_sample+float---.cxx 2012-06-01 16:47:10.089701265 +0200
+@@ -0,0 +1,6 @@
++#include <boxm/basic/boxm_block_vis_graph_iterator.txx>
++#include <boct/boct_tree.txx>
++#include <boxm/sample/boxm_edge_sample.h>
++
++typedef boct_tree<short, boxm_edge_sample<float> > tree_type;
++BOXM_BLOCK_VIS_GRAPH_ITERATOR_INSTANTIATE(tree_type);
+Index: vxl-1.17.0/brl/bseg/boxm/basic/Templates/boxm_block_vis_graph_iterator+boct_tree+short.boxm_edge_tangent_sample+float---.cxx
+===================================================================
+--- /dev/null 1970-01-01 00:00:00.000000000 +0000
++++ vxl-1.17.0/brl/bseg/boxm/basic/Templates/boxm_block_vis_graph_iterator+boct_tree+short.boxm_edge_tangent_sample+float---.cxx 2012-06-01 16:47:10.089701265 +0200
+@@ -0,0 +1,13 @@
++#include <boxm/basic/boxm_block_vis_graph_iterator.txx>
++#include <boct/boct_tree.txx>
++#include <boxm/sample/boxm_edge_tangent_sample.h>
++#include <boxm/sample/boxm_inf_line_sample.h>
++
++typedef boct_tree<short, boxm_edge_tangent_sample<float> > tree_type;
++BOXM_BLOCK_VIS_GRAPH_ITERATOR_INSTANTIATE(tree_type);
++
++typedef boct_tree<short, boxm_inf_line_sample<float> > aux_tree_type;
++BOXM_BLOCK_VIS_GRAPH_ITERATOR_INSTANTIATE(aux_tree_type);
++
++typedef boct_tree<short, float > aux_tree_type2;
++BOXM_BLOCK_VIS_GRAPH_ITERATOR_INSTANTIATE(aux_tree_type2);
+Index: vxl-1.17.0/brl/bpro/core/vil_pro/processes/vil_image_sum_process.cxx
+===================================================================
+--- /dev/null 1970-01-01 00:00:00.000000000 +0000
++++ vxl-1.17.0/brl/bpro/core/vil_pro/processes/vil_image_sum_process.cxx 2012-06-01 16:47:10.093701265 +0200
+@@ -0,0 +1,68 @@
++//this is /brl/bpro/core/vil_pro/processes/vil_image_sum_process.cxx
++#include<bprb/bprb_func_process.h>
++//:
++// \file
++
++#include<vil/vil_convert.h>
++#include<vil/vil_image_resource.h>
++#include<vil/vil_math.h>
++
++namespace vil_image_sum_process_globals
++{
++ const unsigned int n_inputs_ = 2;
++ const unsigned int n_outputs_ = 1;
++}
++
++bool vil_image_sum_process_cons( bprb_func_process& pro )
++{
++ using namespace vil_image_sum_process_globals;
++
++ vcl_vector<vcl_string> input_types_(n_inputs_);
++ vcl_vector<vcl_string> output_types_(n_outputs_);
++
++ unsigned i = 0;
++ input_types_[i++] = "vil_image_view_base_sptr"; // img
++ input_types_[i++] = "unsigned"; // plane index
++
++ output_types_[0] = "double";
++
++ return pro.set_input_types(input_types_)
++ && pro.set_output_types(output_types_)
++ && pro.set_input(1, brdb_value_sptr(new brdb_value_t<unsigned>(0)));
++ //default value
++}
++
++bool vil_image_sum_process( bprb_func_process& pro )
++{
++ using namespace vil_image_sum_process_globals;
++
++ if (pro.n_inputs() != n_inputs_) {
++ vcl_cout << "vil_set_float_image_pixel_process: "
++ << "The number of inputs should be " << n_inputs_ << vcl_endl;
++ return false;
++ }
++
++ unsigned i = 0;
++ vil_image_view_base_sptr imgBaseSptr =
++ pro.get_input<vil_image_view_base_sptr>(i++);
++ unsigned p = pro.get_input<unsigned>(i++);
++
++ // convert to float image
++ vil_image_view<float> fimage;
++ if (imgBaseSptr->pixel_format() == VIL_PIXEL_FORMAT_RGBA_BYTE ) {
++ vil_image_view_base_sptr plane_image = vil_convert_to_n_planes(4, imgBaseSptr);
++ fimage = *vil_convert_cast(float(), plane_image);
++ vil_math_scale_values(fimage, 1.0/255.0);
++ }
++ else {
++ //can use convert cast
++ fimage = *vil_convert_cast(float(), imgBaseSptr);
++ }
++
++ double sum = 0.0;
++ vil_math_sum(sum, fimage, p);
++
++ pro.set_output_val(0,sum);
++
++ return true;
++}
+Index: vxl-1.17.0/brl/bpro/core/vil_pro/Templates/brdb_value_t+bil_raw_image_istream_sptr-.cxx
+===================================================================
+--- /dev/null 1970-01-01 00:00:00.000000000 +0000
++++ vxl-1.17.0/brl/bpro/core/vil_pro/Templates/brdb_value_t+bil_raw_image_istream_sptr-.cxx 2012-06-01 16:47:10.093701265 +0200
+@@ -0,0 +1,4 @@
++#include <brdb/brdb_value.txx>
++#include <bil/bil_raw_image_istream.h>
++
++BRDB_VALUE_INSTANTIATE(bil_raw_image_istream_sptr, "bil_raw_image_istream_sptr");
+Index: vxl-1.17.0/brl/bbas/bwm/bwm_plane_fitting_lsf.cxx
+===================================================================
+--- /dev/null 1970-01-01 00:00:00.000000000 +0000
++++ vxl-1.17.0/brl/bbas/bwm/bwm_plane_fitting_lsf.cxx 2012-06-01 16:47:10.093701265 +0200
+@@ -0,0 +1,23 @@
++#include "bwm_plane_fitting_lsf.h"
++
++#include <vcl_iostream.h>
++#include <vgl/vgl_point_2d.h>
++#include <vgl/vgl_vector_2d.h>
++#include <vsol/vsol_point_2d.h>
++#include <vsol/vsol_point_3d.h>
++
++void bwm_plane_fitting_lsf::f(vnl_vector<double> const &x, vnl_vector< double > &fx)
++{
++ vcl_cerr << "------ d_ == " << x[0] <<" ";
++ d_ = x[0];
++ plane_.set(a_, b_, c_, d_);
++
++ vsol_point_3d_sptr new_pt3d;
++ master_obs_->backproj_point(master_img_pt_, new_pt3d, plane_);
++
++ vgl_point_2d<double> new_img_pt;
++ sec_obs_->proj_point(new_pt3d->get_p(), new_img_pt);
++ vgl_vector_2d<double> v = new_pt_->get_p() - new_img_pt;
++ fx[0] = v.length();
++ vcl_cerr << " fx = " << fx[0] << vcl_endl;
++}
+Index: vxl-1.17.0/brl/bbas/bwm/bwm_plane_fitting_lsf.h
+===================================================================
+--- /dev/null 1970-01-01 00:00:00.000000000 +0000
++++ vxl-1.17.0/brl/bbas/bwm/bwm_plane_fitting_lsf.h 2012-06-01 16:47:10.093701265 +0200
+@@ -0,0 +1,51 @@
++// This is brl/bbas/bwm/algo/bwm_plane_fitting_lsf.h
++#ifndef bwm_plane_fitting_lsf_h_
++#define bwm_plane_fitting_lsf_h_
++//:
++// \file
++// \brief Least Square Function Definition to solve for the right projection plane while moving a polygon to the specified point while keeping the plane in the camera direction of the master camera observer
++//
++// \author Gamze Tunali
++// \date August 20, 2007
++//
++// \verbatim
++// Modifications
++// <none yet>
++// \endverbatim
++
++#include "bwm_observer_cam.h"
++
++#include <vnl/vnl_least_squares_function.h>
++#include <vgl/vgl_homg_plane_3d.h>
++#include <vsol/vsol_point_2d_sptr.h>
++
++class bwm_plane_fitting_lsf : public vnl_least_squares_function
++{
++ public:
++
++ //: 1 unknown (d of projection plane ax+by+cx=d), 1 residual (distance between the current and the destination point)
++ bwm_plane_fitting_lsf(double a, double b, double c, double d,
++ vsol_point_2d_sptr master_img_pt, vsol_point_2d_sptr new_pt,
++ bwm_observer_cam* master_obs, bwm_observer_cam* sec_obs)
++ : vnl_least_squares_function(1, 1, no_gradient),
++ a_(a), b_(b), c_(c), d_(d),
++ master_obs_(master_obs), sec_obs_(sec_obs),
++ master_img_pt_(master_img_pt), new_pt_(new_pt)
++ {}
++
++ virtual ~bwm_plane_fitting_lsf() {}
++
++ virtual void f(vnl_vector<double> const &x, vnl_vector< double > &fx);
++
++ vgl_homg_plane_3d<double> plane() const { return plane_; }
++
++ private:
++ double a_, b_, c_, d_; //parameters of the projection plane
++ vgl_homg_plane_3d<double> plane_;
++ bwm_observer_cam* master_obs_;
++ bwm_observer_cam* sec_obs_;
++ vsol_point_2d_sptr master_img_pt_;
++ vsol_point_2d_sptr new_pt_;
++};
++
++#endif
+Index: vxl-1.17.0/vpgl/io/Templates/vbl_io_smart_ptr+vpgl_camera+double--.cxx
+===================================================================
+--- /dev/null 1970-01-01 00:00:00.000000000 +0000
++++ vxl-1.17.0/vpgl/io/Templates/vbl_io_smart_ptr+vpgl_camera+double--.cxx 2012-06-01 16:47:10.097701265 +0200
+@@ -0,0 +1,6 @@
++#include <vpgl/vpgl_camera.h>
++#include <vpgl/io/vpgl_io_camera.h>
++#include <vbl/io/vbl_io_smart_ptr.txx>
++
++typedef vpgl_camera<double> vpgl_camera_double;
++VBL_IO_SMART_PTR_INSTANTIATE(vpgl_camera_double);
+Index: vxl-1.17.0/vpgl/io/Templates/vbl_io_smart_ptr+vpgl_camera+float--.cxx
+===================================================================
+--- /dev/null 1970-01-01 00:00:00.000000000 +0000
++++ vxl-1.17.0/vpgl/io/Templates/vbl_io_smart_ptr+vpgl_camera+float--.cxx 2012-06-01 16:47:10.097701265 +0200
+@@ -0,0 +1,6 @@
++#include <vpgl/vpgl_camera.h>
++#include <vpgl/io/vpgl_io_camera.h>
++#include <vbl/io/vbl_io_smart_ptr.txx>
++
++typedef vpgl_camera<float> vpgl_camera_float;
++VBL_IO_SMART_PTR_INSTANTIATE(vpgl_camera_float);
Modified: trunk/packages/vxl/branches/experimental/debian/patches/series
===================================================================
--- trunk/packages/vxl/branches/experimental/debian/patches/series 2012-06-01 14:51:00 UTC (rev 11159)
+++ trunk/packages/vxl/branches/experimental/debian/patches/series 2012-06-01 14:51:20 UTC (rev 11160)
@@ -1,3 +1,4 @@
+import_trunk.patch
vxl.soname.patch
sse2.patch
renamelibs.patch
Modified: trunk/packages/vxl/branches/experimental/debian/patches/vxl.soname.patch
===================================================================
--- trunk/packages/vxl/branches/experimental/debian/patches/vxl.soname.patch 2012-06-01 14:51:00 UTC (rev 11159)
+++ trunk/packages/vxl/branches/experimental/debian/patches/vxl.soname.patch 2012-06-01 14:51:20 UTC (rev 11160)
@@ -2,10 +2,10 @@
Author: Mathieu Malaterre <malat at debian.org>
Last-Update: 2011-07-24
-Index: vxl/CMakeLists.txt
+Index: vxl-1.17.0/CMakeLists.txt
===================================================================
---- vxl.orig/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/CMakeLists.txt 2012-06-01 16:12:16.197730174 +0200
+--- vxl-1.17.0.orig/CMakeLists.txt 2012-06-01 15:44:00.729753582 +0200
++++ vxl-1.17.0/CMakeLists.txt 2012-06-01 15:44:08.969753468 +0200
@@ -12,6 +12,26 @@
PROJECT(vxl)
@@ -33,10 +33,10 @@
SET( LIBRARY_OUTPUT_PATH ${vxl_BINARY_DIR}/lib CACHE PATH
"Output directory for the vxl libraries" )
-Index: vxl/v3p/netlib/CMakeLists.txt
+Index: vxl-1.17.0/v3p/netlib/CMakeLists.txt
===================================================================
---- vxl.orig/v3p/netlib/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/v3p/netlib/CMakeLists.txt 2012-06-01 16:12:16.197730174 +0200
+--- vxl-1.17.0.orig/v3p/netlib/CMakeLists.txt 2012-06-01 15:44:00.737753582 +0200
++++ vxl-1.17.0/v3p/netlib/CMakeLists.txt 2012-06-01 15:44:08.969753468 +0200
@@ -8,6 +8,7 @@
)
@@ -53,10 +53,10 @@
INSTALL_TARGETS( /lib v3p_netlib )
INSTALL_NOBASE_HEADER_FILES(/include/vxl/v3p/netlib ${v3p_netlib_sources})
IF(UNIX)
-Index: vxl/contrib/rpl/rsdl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/rpl/rsdl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/rpl/rsdl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/rpl/rsdl/CMakeLists.txt 2012-06-01 16:12:16.197730174 +0200
+--- vxl-1.17.0.orig/contrib/rpl/rsdl/CMakeLists.txt 2012-06-01 15:44:00.781753581 +0200
++++ vxl-1.17.0/contrib/rpl/rsdl/CMakeLists.txt 2012-06-01 15:44:08.969753468 +0200
@@ -21,6 +21,7 @@
ENDIF(CMAKE_COMPILER_IS_GNUCXX)
@@ -65,10 +65,10 @@
INSTALL_TARGETS(/lib rsdl)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/rpl/rsdl ${rsdl_sources})
TARGET_LINK_LIBRARIES( rsdl vnl vbl )
-Index: vxl/contrib/mul/clsfy/CMakeLists.txt
+Index: vxl-1.17.0/contrib/mul/clsfy/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/mul/clsfy/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/mul/clsfy/CMakeLists.txt 2012-06-01 16:12:16.197730174 +0200
+--- vxl-1.17.0.orig/contrib/mul/clsfy/CMakeLists.txt 2012-06-01 15:44:00.821753579 +0200
++++ vxl-1.17.0/contrib/mul/clsfy/CMakeLists.txt 2012-06-01 15:44:08.969753468 +0200
@@ -53,6 +53,7 @@
AUX_SOURCE_DIRECTORY(Templates clsfy_sources)
@@ -77,10 +77,10 @@
INSTALL_TARGETS(/lib clsfy)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/mul/clsfy ${clsfy_sources})
TARGET_LINK_LIBRARIES(clsfy vpdfl mbl vnl_algo vnl_io vnl vbl vsl vul)
-Index: vxl/contrib/mul/vpdfl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/mul/vpdfl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/mul/vpdfl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/mul/vpdfl/CMakeLists.txt 2012-06-01 16:12:16.197730174 +0200
+--- vxl-1.17.0.orig/contrib/mul/vpdfl/CMakeLists.txt 2012-06-01 15:44:00.825753579 +0200
++++ vxl-1.17.0/contrib/mul/vpdfl/CMakeLists.txt 2012-06-01 15:44:08.969753468 +0200
@@ -37,6 +37,7 @@
AUX_SOURCE_DIRECTORY(Templates vpdfl_sources)
@@ -89,10 +89,10 @@
INSTALL_TARGETS(/lib vpdfl)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/mul/vpdfl ${vpdfl_sources})
TARGET_LINK_LIBRARIES(vpdfl mbl vnl_algo vnl_io vnl vsl vul)
-Index: vxl/v3p/Qv/CMakeLists.txt
+Index: vxl-1.17.0/v3p/Qv/CMakeLists.txt
===================================================================
---- vxl.orig/v3p/Qv/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/v3p/Qv/CMakeLists.txt 2012-06-01 16:12:16.197730174 +0200
+--- vxl-1.17.0.orig/v3p/Qv/CMakeLists.txt 2012-06-01 15:44:00.749753580 +0200
++++ vxl-1.17.0/v3p/Qv/CMakeLists.txt 2012-06-01 15:44:08.969753468 +0200
@@ -169,6 +169,7 @@
ENDIF(CMAKE_COMPILER_IS_GNUCXX)
@@ -101,10 +101,10 @@
TARGET_LINK_LIBRARIES( Qv vcl )
-Index: vxl/contrib/prip/vpyr/CMakeLists.txt
+Index: vxl-1.17.0/contrib/prip/vpyr/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/prip/vpyr/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/prip/vpyr/CMakeLists.txt 2012-06-01 16:12:16.197730174 +0200
+--- vxl-1.17.0.orig/contrib/prip/vpyr/CMakeLists.txt 2012-06-01 15:44:00.961753578 +0200
++++ vxl-1.17.0/contrib/prip/vpyr/CMakeLists.txt 2012-06-01 15:44:08.969753468 +0200
@@ -23,6 +23,7 @@
)
@@ -113,10 +113,10 @@
INSTALL_TARGETS(/lib vpyr)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/prip/vpyr ${vpyr_sources})
TARGET_LINK_LIBRARIES(vpyr vmap)
-Index: vxl/core/vgl/algo/CMakeLists.txt
+Index: vxl-1.17.0/core/vgl/algo/CMakeLists.txt
===================================================================
---- vxl.orig/core/vgl/algo/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/core/vgl/algo/CMakeLists.txt 2012-06-01 16:12:16.197730174 +0200
+--- vxl-1.17.0.orig/core/vgl/algo/CMakeLists.txt 2012-06-01 15:44:01.821753567 +0200
++++ vxl-1.17.0/core/vgl/algo/CMakeLists.txt 2012-06-01 15:44:08.969753468 +0200
@@ -44,6 +44,7 @@
AUX_SOURCE_DIRECTORY(Templates vgl_algo_sources)
@@ -125,10 +125,10 @@
TARGET_LINK_LIBRARIES( vgl_algo vgl vnl_algo vnl )
INSTALL_TARGETS(/lib vgl_algo)
-Index: vxl/contrib/brl/bbas/bgrl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bgrl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bgrl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bgrl/CMakeLists.txt 2012-06-01 16:12:16.197730174 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/bgrl/CMakeLists.txt 2012-06-01 15:44:01.021753578 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bgrl/CMakeLists.txt 2012-06-01 15:44:08.969753468 +0200
@@ -19,6 +19,7 @@
AUX_SOURCE_DIRECTORY(Templates bgrl_sources)
@@ -137,10 +137,10 @@
INSTALL_TARGETS(/lib bgrl)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/brl/bbas/bgrl ${bgrl_sources})
-Index: vxl/contrib/brl/bbas/bgrl2/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bgrl2/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bgrl2/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bgrl2/CMakeLists.txt 2012-06-01 16:12:16.201730173 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/bgrl2/CMakeLists.txt 2012-06-01 15:44:01.029753578 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bgrl2/CMakeLists.txt 2012-06-01 15:44:08.969753468 +0200
@@ -17,7 +17,9 @@
)
@@ -152,10 +152,10 @@
TARGET_LINK_LIBRARIES( bgrl2 vbl )
#Algorithms on graphs
-Index: vxl/contrib/gel/vdgl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/gel/vdgl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/gel/vdgl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/gel/vdgl/CMakeLists.txt 2012-06-01 16:12:16.201730173 +0200
+--- vxl-1.17.0.orig/contrib/gel/vdgl/CMakeLists.txt 2012-06-01 15:44:01.561753569 +0200
++++ vxl-1.17.0/contrib/gel/vdgl/CMakeLists.txt 2012-06-01 15:44:08.973753468 +0200
@@ -23,6 +23,7 @@
AUX_SOURCE_DIRECTORY(Templates vdgl_sources)
@@ -164,10 +164,10 @@
INSTALL_TARGETS(/lib vdgl)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/gel/vdgl ${vdgl_sources})
TARGET_LINK_LIBRARIES(vdgl vsol vgl_algo vgl vnl_algo vnl vbl_io vbl vsl vul vcl)
-Index: vxl/contrib/gel/vtol/algo/CMakeLists.txt
+Index: vxl-1.17.0/contrib/gel/vtol/algo/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/gel/vtol/algo/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/gel/vtol/algo/CMakeLists.txt 2012-06-01 16:12:16.201730173 +0200
+--- vxl-1.17.0.orig/contrib/gel/vtol/algo/CMakeLists.txt 2012-06-01 15:44:01.573753570 +0200
++++ vxl-1.17.0/contrib/gel/vtol/algo/CMakeLists.txt 2012-06-01 15:44:08.973753468 +0200
@@ -8,6 +8,7 @@
AUX_SOURCE_DIRECTORY( Templates vtol_algo_sources )
@@ -176,10 +176,10 @@
INSTALL_TARGETS(/lib vtol_algo)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/gel/vtol/algo ${vtol_algo_sources})
TARGET_LINK_LIBRARIES( vtol_algo vtol vsol vdgl vil_algo vgl_algo vgl vil vbl )
-Index: vxl/contrib/gel/vtol/CMakeLists.txt
+Index: vxl-1.17.0/contrib/gel/vtol/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/gel/vtol/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/gel/vtol/CMakeLists.txt 2012-06-01 16:12:16.201730173 +0200
+--- vxl-1.17.0.orig/contrib/gel/vtol/CMakeLists.txt 2012-06-01 15:44:01.585753570 +0200
++++ vxl-1.17.0/contrib/gel/vtol/CMakeLists.txt 2012-06-01 15:44:08.973753468 +0200
@@ -35,6 +35,7 @@
ENDIF(CMAKE_COMPILER_IS_GNUCXX)
@@ -188,10 +188,10 @@
INSTALL_TARGETS(/lib vtol)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/gel/vtol ${vtol_sources})
TARGET_LINK_LIBRARIES(vtol vdgl vsol vnl vbl vul ${CMAKE_THREAD_LIBS})
-Index: vxl/contrib/oxl/mvl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/oxl/mvl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/oxl/mvl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/oxl/mvl/CMakeLists.txt 2012-06-01 16:12:16.201730173 +0200
+--- vxl-1.17.0.orig/contrib/oxl/mvl/CMakeLists.txt 2012-06-01 15:44:01.737753568 +0200
++++ vxl-1.17.0/contrib/oxl/mvl/CMakeLists.txt 2012-06-01 15:44:08.973753468 +0200
@@ -113,6 +113,7 @@
ENDIF(CMAKE_COMPILER_IS_GNUCXX)
@@ -200,10 +200,10 @@
INSTALL_TARGETS(/lib mvl)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/oxl/mvl ${mvl_sources})
TARGET_LINK_LIBRARIES(mvl vil1 vnl_algo vnl vbl vgl vgl_algo vul)
-Index: vxl/contrib/prip/vdtop/CMakeLists.txt
+Index: vxl-1.17.0/contrib/prip/vdtop/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/prip/vdtop/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/prip/vdtop/CMakeLists.txt 2012-06-01 16:12:16.201730173 +0200
+--- vxl-1.17.0.orig/contrib/prip/vdtop/CMakeLists.txt 2012-06-01 15:44:00.973753577 +0200
++++ vxl-1.17.0/contrib/prip/vdtop/CMakeLists.txt 2012-06-01 15:44:08.973753468 +0200
@@ -26,6 +26,7 @@
)
@@ -212,10 +212,10 @@
INSTALL_TARGETS(/lib vdtop)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/prip/vdtop ${vdtop_sources})
TARGET_LINK_LIBRARIES(vdtop vmap vil)
-Index: vxl/contrib/brl/b3p/minizip/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/b3p/minizip/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/b3p/minizip/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/b3p/minizip/CMakeLists.txt 2012-06-01 16:12:16.201730173 +0200
+--- vxl-1.17.0.orig/contrib/brl/b3p/minizip/CMakeLists.txt 2012-06-01 15:44:01.265753573 +0200
++++ vxl-1.17.0/contrib/brl/b3p/minizip/CMakeLists.txt 2012-06-01 15:44:08.973753468 +0200
@@ -22,6 +22,8 @@
ENDIF(WIN32)
@@ -225,10 +225,10 @@
+INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/brl/b3p/minizip ${minizip_sources})
ENDIF(ZLIB_FOUND)
-Index: vxl/contrib/tbl/vipl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/tbl/vipl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/tbl/vipl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/tbl/vipl/CMakeLists.txt 2012-06-01 16:12:16.201730173 +0200
+--- vxl-1.17.0.orig/contrib/tbl/vipl/CMakeLists.txt 2012-06-01 15:44:01.757753567 +0200
++++ vxl-1.17.0/contrib/tbl/vipl/CMakeLists.txt 2012-06-01 15:44:08.973753468 +0200
@@ -77,6 +77,7 @@
ENDIF(CMAKE_COMPILER_IS_GNUCXX)
@@ -237,10 +237,10 @@
INSTALL_TARGETS(/lib vipl)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/tbl/vipl ${vipl_sources})
TARGET_LINK_LIBRARIES(vipl vil vil1 vnl vbl)
-Index: vxl/core/vul/CMakeLists.txt
+Index: vxl-1.17.0/core/vul/CMakeLists.txt
===================================================================
---- vxl.orig/core/vul/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/core/vul/CMakeLists.txt 2012-06-01 16:12:16.201730173 +0200
+--- vxl-1.17.0.orig/core/vul/CMakeLists.txt 2012-06-01 15:44:01.865753566 +0200
++++ vxl-1.17.0/core/vul/CMakeLists.txt 2012-06-01 15:44:08.973753468 +0200
@@ -76,6 +76,7 @@
ENDIF(APPLE)
@@ -249,10 +249,10 @@
TARGET_LINK_LIBRARIES( vul vcl )
INSTALL_NOBASE_HEADER_FILES(/include/vxl/core/vul
-Index: vxl/contrib/brl/bbas/bdgl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bdgl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bdgl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bdgl/CMakeLists.txt 2012-06-01 16:12:16.201730173 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/bdgl/CMakeLists.txt 2012-06-01 15:44:01.045753576 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bdgl/CMakeLists.txt 2012-06-01 15:44:08.973753468 +0200
@@ -20,6 +20,7 @@
)
@@ -261,10 +261,10 @@
INSTALL_TARGETS(/lib bdgl)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/brl/bbas/bdgl ${bdgl_sources})
-Index: vxl/contrib/brl/bbas/bdpg/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bdpg/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bdpg/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bdpg/CMakeLists.txt 2012-06-01 16:12:16.201730173 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/bdpg/CMakeLists.txt 2012-06-01 15:44:01.049753576 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bdpg/CMakeLists.txt 2012-06-01 15:44:08.973753468 +0200
@@ -10,6 +10,7 @@
AUX_SOURCE_DIRECTORY(Templates bdpg_sources)
@@ -273,10 +273,10 @@
INSTALL_TARGETS(/lib bdpg)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/brl/bbas/bdpg ${bdpg_sources})
-Index: vxl/contrib/brl/bbas/bgui/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bgui/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bgui/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bgui/CMakeLists.txt 2012-06-01 16:12:16.201730173 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/bgui/CMakeLists.txt 2012-06-01 15:44:01.057753576 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bgui/CMakeLists.txt 2012-06-01 15:44:08.973753468 +0200
@@ -38,6 +38,7 @@
AUX_SOURCE_DIRECTORY(Templates bgui_sources)
@@ -285,10 +285,10 @@
INSTALL_TARGETS(/lib bgui)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/brl/bbas/bgui ${bgui_sources})
-Index: vxl/contrib/brl/bbas/bgui3d/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bgui3d/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bgui3d/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bgui3d/CMakeLists.txt 2012-06-01 16:12:16.205730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/bgui3d/CMakeLists.txt 2012-06-01 15:44:01.065753577 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bgui3d/CMakeLists.txt 2012-06-01 15:44:08.973753468 +0200
@@ -60,6 +60,7 @@
)
@@ -297,10 +297,10 @@
SET(BGUI3D_FOUND "YES" CACHE INTERNAL "Was bgui3d successfully built?" )
TARGET_LINK_LIBRARIES(bgui3d ${COIN3D_LIBRARY} vgui vpgl vnl_algo vnl vgl_algo vgl vul)
-Index: vxl/contrib/brl/bbas/bil/algo/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bil/algo/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bil/algo/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bil/algo/CMakeLists.txt 2012-06-01 16:12:16.205730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/bil/algo/CMakeLists.txt 2012-06-01 15:44:01.077753577 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bil/algo/CMakeLists.txt 2012-06-01 15:44:08.977753468 +0200
@@ -31,6 +31,9 @@
AUX_SOURCE_DIRECTORY(Templates bil_algo_sources)
@@ -311,10 +311,10 @@
TARGET_LINK_LIBRARIES( bil_algo vil_algo vil vnl_algo vnl vgl_algo vgl vbl vsol)
-Index: vxl/contrib/brl/bbas/bil/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bil/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bil/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bil/CMakeLists.txt 2012-06-01 16:12:16.205730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/bil/CMakeLists.txt 2012-06-01 15:44:01.085753577 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bil/CMakeLists.txt 2012-06-01 15:44:08.977753468 +0200
@@ -11,6 +11,9 @@
AUX_SOURCE_DIRECTORY(Templates bil_sources)
@@ -325,10 +325,10 @@
TARGET_LINK_LIBRARIES(bil vil vil_io vsl vidl)
-Index: vxl/contrib/brl/bbas/bmsh3d/algo/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bmsh3d/algo/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bmsh3d/algo/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bmsh3d/algo/CMakeLists.txt 2012-06-01 16:12:16.205730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/bmsh3d/algo/CMakeLists.txt 2012-06-01 15:44:01.097753577 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bmsh3d/algo/CMakeLists.txt 2012-06-01 15:44:08.977753468 +0200
@@ -13,6 +13,9 @@
)
@@ -339,10 +339,10 @@
TARGET_LINK_LIBRARIES( bmsh3d_algo bmsh3d rply vgl vnl vul)
IF( BUILD_TESTING )
-Index: vxl/contrib/brl/bbas/bnl/algo/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bnl/algo/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bnl/algo/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bnl/algo/CMakeLists.txt 2012-06-01 16:12:16.205730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/bnl/algo/CMakeLists.txt 2012-06-01 15:44:01.117753575 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bnl/algo/CMakeLists.txt 2012-06-01 15:44:08.977753468 +0200
@@ -5,6 +5,7 @@
)
@@ -351,10 +351,10 @@
INSTALL_TARGETS(/lib bnl_algo)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/brl/bbas/bnl/algo ${bnl_algo_sources})
TARGET_LINK_LIBRARIES( bnl_algo vnl )
-Index: vxl/contrib/brl/bbas/bnl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bnl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bnl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bnl/CMakeLists.txt 2012-06-01 16:12:16.205730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/bnl/CMakeLists.txt 2012-06-01 15:44:01.125753575 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bnl/CMakeLists.txt 2012-06-01 15:44:08.977753468 +0200
@@ -8,6 +8,7 @@
)
@@ -363,10 +363,10 @@
INSTALL_TARGETS(/lib bnl)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/brl/bbas/bnl ${bnl_sources})
-Index: vxl/contrib/brl/bbas/bsol/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bsol/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bsol/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bsol/CMakeLists.txt 2012-06-01 16:12:16.205730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/bsol/CMakeLists.txt 2012-06-01 15:44:01.133753575 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bsol/CMakeLists.txt 2012-06-01 15:44:08.977753468 +0200
@@ -24,6 +24,7 @@
AUX_SOURCE_DIRECTORY(Templates bsol_sources)
@@ -375,10 +375,10 @@
INSTALL_TARGETS(/lib bsol)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/brl/bbas/bsol ${bsol_sources})
TARGET_LINK_LIBRARIES(bsol vsol vgl_algo vgl vnl vbl)
-Index: vxl/contrib/brl/bbas/bsta/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bsta/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bsta/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bsta/CMakeLists.txt 2012-06-01 16:12:16.205730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/bsta/CMakeLists.txt 2012-06-01 15:44:01.149753576 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bsta/CMakeLists.txt 2012-06-01 15:44:08.977753468 +0200
@@ -62,6 +62,7 @@
AUX_SOURCE_DIRECTORY(Templates bsta_sources)
@@ -387,10 +387,10 @@
INSTALL_TARGETS(/lib bsta)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/bsta ${bsta_sources})
-Index: vxl/contrib/brl/bbas/bsta/vis/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bsta/vis/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bsta/vis/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bsta/vis/CMakeLists.txt 2012-06-01 16:12:16.205730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/bsta/vis/CMakeLists.txt 2012-06-01 15:44:01.153753576 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bsta/vis/CMakeLists.txt 2012-06-01 15:44:08.977753468 +0200
@@ -8,6 +8,9 @@
)
@@ -401,10 +401,10 @@
TARGET_LINK_LIBRARIES( bsta_vis bsta bsvg vnl )
-Index: vxl/contrib/brl/bbas/btol/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/btol/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/btol/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/btol/CMakeLists.txt 2012-06-01 16:12:16.205730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/btol/CMakeLists.txt 2012-06-01 15:44:01.165753576 +0200
++++ vxl-1.17.0/contrib/brl/bbas/btol/CMakeLists.txt 2012-06-01 15:44:08.977753468 +0200
@@ -19,6 +19,7 @@
)
@@ -413,10 +413,10 @@
INSTALL_TARGETS(/lib btol)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/btol ${btol_sources})
-Index: vxl/contrib/brl/bbas/bugl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bugl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bugl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bugl/CMakeLists.txt 2012-06-01 16:12:16.205730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/bugl/CMakeLists.txt 2012-06-01 15:44:01.173753576 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bugl/CMakeLists.txt 2012-06-01 15:44:08.977753468 +0200
@@ -26,6 +26,7 @@
AUX_SOURCE_DIRECTORY(Templates bugl_sources)
@@ -425,10 +425,10 @@
INSTALL_TARGETS(/lib bugl)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/brl/bbas/bugl ${bugl_sources})
TARGET_LINK_LIBRARIES(bugl vnl vgl_algo vgl vbl)
-Index: vxl/contrib/brl/bbas/bvgl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bvgl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bvgl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bvgl/CMakeLists.txt 2012-06-01 16:12:16.209730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/bvgl/CMakeLists.txt 2012-06-01 15:44:01.185753574 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bvgl/CMakeLists.txt 2012-06-01 15:44:08.977753468 +0200
@@ -38,6 +38,7 @@
#Create BVGL library
@@ -437,11 +437,11 @@
INSTALL_TARGETS(/lib bvgl)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/brl/bbas/bvgl ${bvgl_sources})
TARGET_LINK_LIBRARIES(bvgl vsol vgl_algo vgl_io vgl vnl_algo vnl vil vbl)
-Index: vxl/contrib/brl/bbas/bwm/algo/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bwm/algo/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bwm/algo/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bwm/algo/CMakeLists.txt 2012-06-01 16:12:16.209730172 +0200
-@@ -31,6 +31,9 @@
+--- vxl-1.17.0.orig/contrib/brl/bbas/bwm/algo/CMakeLists.txt 2012-06-01 15:44:01.205753574 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bwm/algo/CMakeLists.txt 2012-06-01 15:44:08.977753468 +0200
+@@ -32,6 +32,9 @@
ENDIF(ECW_FOUND)
ADD_LIBRARY(bwm_algo ${bwm_algo_sources})
@@ -449,12 +449,12 @@
+INSTALL_TARGETS(/lib bwm_algo)
+INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/brl/bbas/bwm/algo ${bwm_algo})
- TARGET_LINK_LIBRARIES( bwm_algo sdet vtol vil vil_algo vgl vgl_algo vnl vnl_algo vsol vpgl vpgl_algo vpgl_file_formats bgui brip vdgl bsta vgui vul vcl shapelib )
+ TARGET_LINK_LIBRARIES( bwm_algo bwm sdet vtol vil vil_algo vgl vgl_algo vnl vnl_algo vsol vpgl vpgl_algo vpgl_file_formats bgui brip vdgl bsta vgui vul vcl shapelib )
-Index: vxl/contrib/brl/bbas/bxml/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bxml/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bxml/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bxml/CMakeLists.txt 2012-06-01 16:12:16.209730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/bxml/CMakeLists.txt 2012-06-01 15:44:01.217753575 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bxml/CMakeLists.txt 2012-06-01 15:44:08.977753468 +0200
@@ -27,6 +27,9 @@
AUX_SOURCE_DIRECTORY(Templates bxml_sources)
@@ -465,10 +465,10 @@
TARGET_LINK_LIBRARIES( bxml vbl_io vul vbl )
IF(EXPAT_FOUND)
-Index: vxl/contrib/brl/bbas/imesh/algo/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/imesh/algo/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/imesh/algo/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/imesh/algo/CMakeLists.txt 2012-06-01 16:12:16.209730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/imesh/algo/CMakeLists.txt 2012-06-01 15:44:01.237753575 +0200
++++ vxl-1.17.0/contrib/brl/bbas/imesh/algo/CMakeLists.txt 2012-06-01 15:44:08.981753468 +0200
@@ -23,6 +23,9 @@
ENDIF (NETLIB_FOUND)
@@ -479,11 +479,25 @@
IF(NETLIB_FOUND)
-Index: vxl/contrib/brl/bpro/core/bvgl_pro/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bpro/core/brip_pro/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bpro/core/bvgl_pro/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bpro/core/bvgl_pro/CMakeLists.txt 2012-06-01 16:12:16.209730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bpro/core/brip_pro/CMakeLists.txt 2012-06-01 15:44:01.285753574 +0200
++++ vxl-1.17.0/contrib/brl/bpro/core/brip_pro/CMakeLists.txt 2012-06-01 15:44:08.981753468 +0200
@@ -14,6 +14,9 @@
+ AUX_SOURCE_DIRECTORY(processes brip_pro_sources)
+
+ ADD_LIBRARY(brip_pro ${brip_pro_sources})
++SET_TARGET_PROPERTIES(brip_pro PROPERTIES ${VNL_LIBRARY_PROPERTIES})
++INSTALL_TARGETS(/lib brip_pro)
++INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/brl/bpro/core/brip_pro ${brip_pro_sources})
+ TARGET_LINK_LIBRARIES(brip_pro bprb brdb brip vil_pro vil vsl)
+
+ IF( BUILD_TESTING )
+Index: vxl-1.17.0/contrib/brl/bpro/core/bvgl_pro/CMakeLists.txt
+===================================================================
+--- vxl-1.17.0.orig/contrib/brl/bpro/core/bvgl_pro/CMakeLists.txt 2012-06-01 15:44:01.297753574 +0200
++++ vxl-1.17.0/contrib/brl/bpro/core/bvgl_pro/CMakeLists.txt 2012-06-01 15:44:08.981753468 +0200
+@@ -14,6 +14,9 @@
AUX_SOURCE_DIRECTORY(processes bvgl_pro_sources)
ADD_LIBRARY(bvgl_pro ${bvgl_pro_sources})
@@ -493,10 +507,10 @@
TARGET_LINK_LIBRARIES(bvgl_pro bprb vil_pro bvgl vil vil_io)
-Index: vxl/contrib/brl/bpro/core/vil_pro/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bpro/core/vil_pro/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bpro/core/vil_pro/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bpro/core/vil_pro/CMakeLists.txt 2012-06-01 16:12:16.209730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bpro/core/vil_pro/CMakeLists.txt 2012-06-01 15:44:01.329753572 +0200
++++ vxl-1.17.0/contrib/brl/bpro/core/vil_pro/CMakeLists.txt 2012-06-01 15:44:08.981753468 +0200
@@ -16,6 +16,9 @@
AUX_SOURCE_DIRECTORY(processes vil_pro_sources)
@@ -507,10 +521,10 @@
TARGET_LINK_LIBRARIES(vil_pro bbas_pro bprb bil bil_algo vil_algo vil_io vil vnl vul vsl)
-Index: vxl/contrib/brl/bseg/bmdl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bseg/bmdl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bseg/bmdl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bseg/bmdl/CMakeLists.txt 2012-06-01 16:12:16.209730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bseg/bmdl/CMakeLists.txt 2012-06-01 15:44:01.361753573 +0200
++++ vxl-1.17.0/contrib/brl/bseg/bmdl/CMakeLists.txt 2012-06-01 15:44:08.981753468 +0200
@@ -16,6 +16,9 @@
AUX_SOURCE_DIRECTORY(Templates bmdl_sources)
@@ -521,10 +535,10 @@
TARGET_LINK_LIBRARIES(bmdl vil_algo imesh vgl_algo vgl vnl vil)
-Index: vxl/contrib/brl/bseg/bmdl/pro/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bseg/bmdl/pro/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bseg/bmdl/pro/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bseg/bmdl/pro/CMakeLists.txt 2012-06-01 16:12:16.209730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bseg/bmdl/pro/CMakeLists.txt 2012-06-01 15:44:01.369753573 +0200
++++ vxl-1.17.0/contrib/brl/bseg/bmdl/pro/CMakeLists.txt 2012-06-01 15:44:08.981753468 +0200
@@ -31,6 +31,9 @@
AUX_SOURCE_DIRECTORY(processes bmdl_pro_sources)
@@ -535,10 +549,10 @@
TARGET_LINK_LIBRARIES(bmdl_pro bmdl bprb vil vil_io vpgl_file_formats vgl_io
vsol brip vpgl_pro vgl vul vpl imesh_algo minizip)
-Index: vxl/contrib/brl/bseg/boxm/algo/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bseg/boxm/algo/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bseg/boxm/algo/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bseg/boxm/algo/CMakeLists.txt 2012-06-01 16:12:16.209730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bseg/boxm/algo/CMakeLists.txt 2012-06-01 15:44:01.377753573 +0200
++++ vxl-1.17.0/contrib/brl/bseg/boxm/algo/CMakeLists.txt 2012-06-01 15:44:08.981753468 +0200
@@ -20,6 +20,9 @@
)
@@ -549,10 +563,10 @@
IF( BUILD_TESTING )
SUBDIRS(tests)
-Index: vxl/contrib/brl/bseg/boxm/algo/pro/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bseg/boxm/algo/pro/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bseg/boxm/algo/pro/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bseg/boxm/algo/pro/CMakeLists.txt 2012-06-01 16:12:16.209730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bseg/boxm/algo/pro/CMakeLists.txt 2012-06-01 15:44:01.381753573 +0200
++++ vxl-1.17.0/contrib/brl/bseg/boxm/algo/pro/CMakeLists.txt 2012-06-01 15:44:08.981753468 +0200
@@ -19,6 +19,9 @@
AUX_SOURCE_DIRECTORY(processes boxm_algo_pro_sources)
@@ -563,10 +577,10 @@
TARGET_LINK_LIBRARIES(boxm_algo_pro boxm_algo boxm boxm_sample boxm_util boct bprb brdb bsta_pro vil_pro bsta vpgl_pro vpgl vpgl_algo vil vsol vgl brip vcl rply)
# Need bsta_pro only for the instantiation of brdb_value_t<vbl_smart_ptr<bsta_histogram_base> >
-Index: vxl/contrib/brl/bseg/brip/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bseg/brip/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bseg/brip/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bseg/brip/CMakeLists.txt 2012-06-01 16:12:16.209730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bseg/brip/CMakeLists.txt 2012-06-01 15:44:01.409753571 +0200
++++ vxl-1.17.0/contrib/brl/bseg/brip/CMakeLists.txt 2012-06-01 15:44:08.981753468 +0200
@@ -40,6 +40,7 @@
AUX_SOURCE_DIRECTORY(Templates brip_sources)
@@ -575,10 +589,10 @@
INSTALL_TARGETS(/lib brip)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/brl/bseg/brip ${brip_sources})
-Index: vxl/contrib/brl/bseg/bvpl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bseg/bvpl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bseg/bvpl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bseg/bvpl/CMakeLists.txt 2012-06-01 16:12:16.209730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bseg/bvpl/CMakeLists.txt 2012-06-01 15:44:01.437753572 +0200
++++ vxl-1.17.0/contrib/brl/bseg/bvpl/CMakeLists.txt 2012-06-01 15:44:08.985753468 +0200
@@ -19,6 +19,9 @@
AUX_SOURCE_DIRECTORY(Templates bvpl_sources)
@@ -589,10 +603,10 @@
TARGET_LINK_LIBRARIES(bvpl bvpl_kernels bvpl_functors bvxm_grid bdgl bsta vnl vnl_io vil_algo vgl vpl vul vbl_io vsl vbl)
-Index: vxl/contrib/brl/bseg/bvxm/algo/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bseg/bvxm/algo/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bseg/bvxm/algo/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bseg/bvxm/algo/CMakeLists.txt 2012-06-01 16:12:16.213730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bseg/bvxm/algo/CMakeLists.txt 2012-06-01 15:44:01.485753570 +0200
++++ vxl-1.17.0/contrib/brl/bseg/bvxm/algo/CMakeLists.txt 2012-06-01 15:44:08.985753468 +0200
@@ -12,6 +12,9 @@
AUX_SOURCE_DIRECTORY(Templates bvxm_algo_sources)
@@ -603,10 +617,10 @@
TARGET_LINK_LIBRARIES( bvxm_algo bsta bvxm_grid_io boxm_util vnl vgl)
-Index: vxl/contrib/brl/bseg/sdet/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bseg/sdet/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bseg/sdet/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bseg/sdet/CMakeLists.txt 2012-06-01 16:12:16.213730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bseg/sdet/CMakeLists.txt 2012-06-01 15:44:01.513753571 +0200
++++ vxl-1.17.0/contrib/brl/bseg/sdet/CMakeLists.txt 2012-06-01 15:44:08.985753468 +0200
@@ -55,6 +55,7 @@
AUX_SOURCE_DIRECTORY(Templates sdet_sources)
@@ -615,10 +629,10 @@
INSTALL_TARGETS(/lib sdet)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/brl/bseg/sdet ${sdet_sources})
-Index: vxl/contrib/brl/bseg/segv/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bseg/segv/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bseg/segv/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bseg/segv/CMakeLists.txt 2012-06-01 16:12:16.213730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bseg/segv/CMakeLists.txt 2012-06-01 15:44:01.521753571 +0200
++++ vxl-1.17.0/contrib/brl/bseg/segv/CMakeLists.txt 2012-06-01 15:44:08.985753468 +0200
@@ -33,6 +33,7 @@
)
@@ -627,10 +641,10 @@
INSTALL_TARGETS(/lib segv)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/brl/bseg/segv ${segv_sources})
-Index: vxl/contrib/gel/geml/CMakeLists.txt
+Index: vxl-1.17.0/contrib/gel/geml/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/gel/geml/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/gel/geml/CMakeLists.txt 2012-06-01 16:12:16.213730172 +0200
+--- vxl-1.17.0.orig/contrib/gel/geml/CMakeLists.txt 2012-06-01 15:44:01.593753570 +0200
++++ vxl-1.17.0/contrib/gel/geml/CMakeLists.txt 2012-06-01 15:44:08.985753468 +0200
@@ -12,6 +12,7 @@
)
@@ -639,10 +653,10 @@
INSTALL_TARGETS(/lib geml)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/gel/geml ${geml_sources})
TARGET_LINK_LIBRARIES(geml vil1 vnl)
-Index: vxl/contrib/gel/gevd/CMakeLists.txt
+Index: vxl-1.17.0/contrib/gel/gevd/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/gel/gevd/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/gel/gevd/CMakeLists.txt 2012-06-01 16:12:16.213730172 +0200
+--- vxl-1.17.0.orig/contrib/gel/gevd/CMakeLists.txt 2012-06-01 15:44:01.601753570 +0200
++++ vxl-1.17.0/contrib/gel/gevd/CMakeLists.txt 2012-06-01 15:44:08.985753468 +0200
@@ -33,6 +33,7 @@
ENDIF(CMAKE_COMPILER_IS_GNUCXX)
@@ -651,10 +665,10 @@
INSTALL_TARGETS(/lib gevd)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/gel/gevd ${gevd_sources})
TARGET_LINK_LIBRARIES(gevd vtol vsol vdgl vil1 vil vnl vgl vbl vul)
-Index: vxl/contrib/gel/gkll/CMakeLists.txt
+Index: vxl-1.17.0/contrib/gel/gkll/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/gel/gkll/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/gel/gkll/CMakeLists.txt 2012-06-01 16:12:16.213730172 +0200
+--- vxl-1.17.0.orig/contrib/gel/gkll/CMakeLists.txt 2012-06-01 15:44:01.609753570 +0200
++++ vxl-1.17.0/contrib/gel/gkll/CMakeLists.txt 2012-06-01 15:44:08.989753468 +0200
@@ -20,6 +20,7 @@
ENDIF(BUILD_OXL)
@@ -663,10 +677,10 @@
INSTALL_TARGETS(/lib gkll)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/gel/gkll ${gkll_sources})
-Index: vxl/contrib/gel/gmvl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/gel/gmvl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/gel/gmvl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/gel/gmvl/CMakeLists.txt 2012-06-01 16:12:16.213730172 +0200
+--- vxl-1.17.0.orig/contrib/gel/gmvl/CMakeLists.txt 2012-06-01 15:44:01.617753568 +0200
++++ vxl-1.17.0/contrib/gel/gmvl/CMakeLists.txt 2012-06-01 15:44:08.989753468 +0200
@@ -21,6 +21,7 @@
AUX_SOURCE_DIRECTORY(Templates gmvl_sources)
@@ -675,10 +689,10 @@
INSTALL_TARGETS(/lib gmvl)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/gel/gmvl ${gmvl_sources})
TARGET_LINK_LIBRARIES(gmvl vtol vil1 vnl vbl vcl)
-Index: vxl/contrib/gel/gst/CMakeLists.txt
+Index: vxl-1.17.0/contrib/gel/gst/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/gel/gst/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/gel/gst/CMakeLists.txt 2012-06-01 16:12:16.213730172 +0200
+--- vxl-1.17.0.orig/contrib/gel/gst/CMakeLists.txt 2012-06-01 15:44:01.621753568 +0200
++++ vxl-1.17.0/contrib/gel/gst/CMakeLists.txt 2012-06-01 15:44:08.989753468 +0200
@@ -17,6 +17,7 @@
AUX_SOURCE_DIRECTORY(Templates gst_sources)
@@ -687,10 +701,10 @@
INSTALL_TARGETS(/lib gst)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/gel/gst ${gst_sources})
-Index: vxl/contrib/gel/gtrl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/gel/gtrl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/gel/gtrl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/gel/gtrl/CMakeLists.txt 2012-06-01 16:12:16.213730172 +0200
+--- vxl-1.17.0.orig/contrib/gel/gtrl/CMakeLists.txt 2012-06-01 15:44:01.629753568 +0200
++++ vxl-1.17.0/contrib/gel/gtrl/CMakeLists.txt 2012-06-01 15:44:08.989753468 +0200
@@ -25,6 +25,7 @@
ENDIF(NETLIB_FOUND)
@@ -699,10 +713,10 @@
INSTALL_TARGETS(/lib gtrl)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/gel/gtrl ${gtrl_sources})
-Index: vxl/contrib/gel/vgel/CMakeLists.txt
+Index: vxl-1.17.0/contrib/gel/vgel/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/gel/vgel/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/gel/vgel/CMakeLists.txt 2012-06-01 16:12:16.213730172 +0200
+--- vxl-1.17.0.orig/contrib/gel/vgel/CMakeLists.txt 2012-06-01 15:44:01.673753569 +0200
++++ vxl-1.17.0/contrib/gel/vgel/CMakeLists.txt 2012-06-01 15:44:08.989753468 +0200
@@ -20,6 +20,7 @@
ENDIF(BUILD_OXL)
@@ -711,10 +725,10 @@
INSTALL_TARGETS(/lib vgel)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/gel/vgel ${vgel_sources})
-Index: vxl/contrib/gel/vgel/kl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/gel/vgel/kl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/gel/vgel/kl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/gel/vgel/kl/CMakeLists.txt 2012-06-01 16:12:16.213730172 +0200
+--- vxl-1.17.0.orig/contrib/gel/vgel/kl/CMakeLists.txt 2012-06-01 15:44:01.685753568 +0200
++++ vxl-1.17.0/contrib/gel/vgel/kl/CMakeLists.txt 2012-06-01 15:44:08.989753468 +0200
@@ -15,6 +15,7 @@
)
@@ -723,10 +737,10 @@
INSTALL_TARGETS(/lib vgel_kl)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/gel/vgel/kl ${vgel_kl_sources})
-Index: vxl/contrib/gel/vifa/CMakeLists.txt
+Index: vxl-1.17.0/contrib/gel/vifa/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/gel/vifa/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/gel/vifa/CMakeLists.txt 2012-06-01 16:12:16.213730172 +0200
+--- vxl-1.17.0.orig/contrib/gel/vifa/CMakeLists.txt 2012-06-01 15:44:01.697753567 +0200
++++ vxl-1.17.0/contrib/gel/vifa/CMakeLists.txt 2012-06-01 15:44:08.989753468 +0200
@@ -31,6 +31,7 @@
AUX_SOURCE_DIRECTORY(Templates vifa_sources)
@@ -735,10 +749,10 @@
INSTALL_TARGETS(/lib vifa)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/gel/vifa ${vifa_sources})
TARGET_LINK_LIBRARIES(vifa gevd vtol vsol vdgl vnl vgl vbl vul vil vcl)
-Index: vxl/contrib/gel/vmal/CMakeLists.txt
+Index: vxl-1.17.0/contrib/gel/vmal/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/gel/vmal/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/gel/vmal/CMakeLists.txt 2012-06-01 16:12:16.213730172 +0200
+--- vxl-1.17.0.orig/contrib/gel/vmal/CMakeLists.txt 2012-06-01 15:44:01.705753567 +0200
++++ vxl-1.17.0/contrib/gel/vmal/CMakeLists.txt 2012-06-01 15:44:08.989753468 +0200
@@ -37,6 +37,7 @@
@@ -747,10 +761,10 @@
INSTALL_TARGETS(/lib vmal)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/gel/vmal ${vmal_sources})
-Index: vxl/contrib/gel/vsol/CMakeLists.txt
+Index: vxl-1.17.0/contrib/gel/vsol/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/gel/vsol/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/gel/vsol/CMakeLists.txt 2012-06-01 16:12:16.213730172 +0200
+--- vxl-1.17.0.orig/contrib/gel/vsol/CMakeLists.txt 2012-06-01 15:44:01.713753567 +0200
++++ vxl-1.17.0/contrib/gel/vsol/CMakeLists.txt 2012-06-01 15:44:08.989753468 +0200
@@ -63,6 +63,7 @@
AUX_SOURCE_DIRECTORY(Templates vsol_sources)
@@ -759,10 +773,10 @@
INSTALL_TARGETS(/lib vsol)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/gel/vsol ${vsol_sources})
TARGET_LINK_LIBRARIES(vsol vgl_algo vgl_io vgl vnl vbl_io vbl vsl vul vcl)
-Index: vxl/contrib/gel/vsrl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/gel/vsrl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/gel/vsrl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/gel/vsrl/CMakeLists.txt 2012-06-01 16:12:16.213730172 +0200
+--- vxl-1.17.0.orig/contrib/gel/vsrl/CMakeLists.txt 2012-06-01 15:44:01.729753568 +0200
++++ vxl-1.17.0/contrib/gel/vsrl/CMakeLists.txt 2012-06-01 15:44:08.989753468 +0200
@@ -60,6 +60,7 @@
ENDIF (HAS_VGUI)
@@ -771,10 +785,10 @@
INSTALL_TARGETS(/lib vsrl)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/gel/vsrl ${vsrl_sources})
-Index: vxl/contrib/mul/ipts/CMakeLists.txt
+Index: vxl-1.17.0/contrib/mul/ipts/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/mul/ipts/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/mul/ipts/CMakeLists.txt 2012-06-01 16:12:16.213730172 +0200
+--- vxl-1.17.0.orig/contrib/mul/ipts/CMakeLists.txt 2012-06-01 15:44:00.837753579 +0200
++++ vxl-1.17.0/contrib/mul/ipts/CMakeLists.txt 2012-06-01 15:44:08.989753468 +0200
@@ -16,6 +16,7 @@
)
@@ -783,10 +797,10 @@
INSTALL_TARGETS(/lib ipts)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/mul/ipts ${ipts_sources})
TARGET_LINK_LIBRARIES(ipts vimt_algo vimt vgl vil_algo vil)
-Index: vxl/contrib/mul/mbl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/mul/mbl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/mul/mbl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/mul/mbl/CMakeLists.txt 2012-06-01 16:12:16.213730172 +0200
+--- vxl-1.17.0.orig/contrib/mul/mbl/CMakeLists.txt 2012-06-01 15:44:00.845753579 +0200
++++ vxl-1.17.0/contrib/mul/mbl/CMakeLists.txt 2012-06-01 15:44:08.993753468 +0200
@@ -121,6 +121,7 @@
ENDIF(CMAKE_COMPILER_IS_GNUCXX)
@@ -795,10 +809,10 @@
TARGET_LINK_LIBRARIES(mbl vnl_io vnl_algo vgl_io vgl vbl_io vil_io vsl vnl vil vul vbl)
INSTALL_TARGETS(/lib mbl)
-Index: vxl/contrib/mul/mil/algo/CMakeLists.txt
+Index: vxl-1.17.0/contrib/mul/mil/algo/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/mul/mil/algo/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/mul/mil/algo/CMakeLists.txt 2012-06-01 16:12:16.213730172 +0200
+--- vxl-1.17.0.orig/contrib/mul/mil/algo/CMakeLists.txt 2012-06-01 15:44:00.865753580 +0200
++++ vxl-1.17.0/contrib/mul/mil/algo/CMakeLists.txt 2012-06-01 15:44:08.993753468 +0200
@@ -15,6 +15,7 @@
AUX_SOURCE_DIRECTORY(Templates mil_algo_sources)
@@ -807,10 +821,10 @@
INSTALL_TARGETS(/lib mil_algo)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/mul/mil/algo ${mil_algo_sources})
TARGET_LINK_LIBRARIES(mil_algo mil mbl vnl vsl)
-Index: vxl/contrib/mul/mil/CMakeLists.txt
+Index: vxl-1.17.0/contrib/mul/mil/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/mul/mil/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/mul/mil/CMakeLists.txt 2012-06-01 16:12:16.213730172 +0200
+--- vxl-1.17.0.orig/contrib/mul/mil/CMakeLists.txt 2012-06-01 15:44:00.873753580 +0200
++++ vxl-1.17.0/contrib/mul/mil/CMakeLists.txt 2012-06-01 15:44:08.993753468 +0200
@@ -37,6 +37,7 @@
AUX_SOURCE_DIRECTORY(Templates mil_sources)
@@ -819,10 +833,10 @@
INSTALL_TARGETS(/lib mil)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/mul/mil ${mil_sources})
TARGET_LINK_LIBRARIES(mil mbl vimt vnl vbl_io vgl vil1 vbl vsl)
-Index: vxl/contrib/mul/mil3d/CMakeLists.txt
+Index: vxl-1.17.0/contrib/mul/mil3d/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/mul/mil3d/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/mul/mil3d/CMakeLists.txt 2012-06-01 16:12:16.217730172 +0200
+--- vxl-1.17.0.orig/contrib/mul/mil3d/CMakeLists.txt 2012-06-01 15:44:00.881753580 +0200
++++ vxl-1.17.0/contrib/mul/mil3d/CMakeLists.txt 2012-06-01 15:44:08.993753468 +0200
@@ -20,6 +20,7 @@
AUX_SOURCE_DIRECTORY(Templates mil3d_sources)
@@ -831,10 +845,10 @@
INSTALL_TARGETS(/lib mil3d)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/mul/mil3d ${mil3d_sources})
TARGET_LINK_LIBRARIES(mil3d mil vbl_io vnl_io vnl vgl vbl vsl)
-Index: vxl/contrib/mul/mvl2/CMakeLists.txt
+Index: vxl-1.17.0/contrib/mul/mvl2/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/mul/mvl2/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/mul/mvl2/CMakeLists.txt 2012-06-01 16:12:16.217730172 +0200
+--- vxl-1.17.0.orig/contrib/mul/mvl2/CMakeLists.txt 2012-06-01 15:44:00.893753578 +0200
++++ vxl-1.17.0/contrib/mul/mvl2/CMakeLists.txt 2012-06-01 15:44:08.993753468 +0200
@@ -52,6 +52,7 @@
ENDIF (AVIFILE_FOUND)
@@ -843,10 +857,10 @@
INSTALL_TARGETS(/lib mvl2)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/mul/mvl2 ${mvl2_sources})
TARGET_LINK_LIBRARIES( mvl2 vil vul ${AVIFILE_LIBRARIES} )
-Index: vxl/contrib/mul/pdf1d/CMakeLists.txt
+Index: vxl-1.17.0/contrib/mul/pdf1d/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/mul/pdf1d/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/mul/pdf1d/CMakeLists.txt 2012-06-01 16:12:16.217730172 +0200
+--- vxl-1.17.0.orig/contrib/mul/pdf1d/CMakeLists.txt 2012-06-01 15:44:00.897753578 +0200
++++ vxl-1.17.0/contrib/mul/pdf1d/CMakeLists.txt 2012-06-01 15:44:08.993753468 +0200
@@ -49,6 +49,7 @@
AUX_SOURCE_DIRECTORY(Templates pdf1d_sources)
@@ -855,10 +869,10 @@
INSTALL_TARGETS(/lib pdf1d)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/mul/pdf1d ${pdf1d_sources})
TARGET_LINK_LIBRARIES( pdf1d mbl vbl vnl_io vnl vsl )
-Index: vxl/contrib/mul/vil3d/algo/CMakeLists.txt
+Index: vxl-1.17.0/contrib/mul/vil3d/algo/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/mul/vil3d/algo/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/mul/vil3d/algo/CMakeLists.txt 2012-06-01 16:12:16.217730172 +0200
+--- vxl-1.17.0.orig/contrib/mul/vil3d/algo/CMakeLists.txt 2012-06-01 15:44:00.905753578 +0200
++++ vxl-1.17.0/contrib/mul/vil3d/algo/CMakeLists.txt 2012-06-01 15:44:08.993753468 +0200
@@ -36,6 +36,7 @@
AUX_SOURCE_DIRECTORY(Templates vil3d_algo_sources)
@@ -867,10 +881,10 @@
INSTALL_TARGETS(/lib vil3d_algo)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/mul/vil3d/algo ${vil3d_algo_sources})
TARGET_LINK_LIBRARIES( vil3d_algo vil3d vil_algo vil vnl vgl )
-Index: vxl/contrib/mul/vil3d/CMakeLists.txt
+Index: vxl-1.17.0/contrib/mul/vil3d/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/mul/vil3d/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/mul/vil3d/CMakeLists.txt 2012-06-01 16:12:16.217730172 +0200
+--- vxl-1.17.0.orig/contrib/mul/vil3d/CMakeLists.txt 2012-06-01 15:44:00.909753578 +0200
++++ vxl-1.17.0/contrib/mul/vil3d/CMakeLists.txt 2012-06-01 15:44:08.993753468 +0200
@@ -49,6 +49,7 @@
AUX_SOURCE_DIRECTORY(Templates vil3d_sources)
@@ -879,10 +893,10 @@
TARGET_LINK_LIBRARIES( vil3d vil vul vsl vcl vnl )
INSTALL_TARGETS(/lib vil3d)
-Index: vxl/contrib/mul/vil3d/io/CMakeLists.txt
+Index: vxl-1.17.0/contrib/mul/vil3d/io/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/mul/vil3d/io/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/mul/vil3d/io/CMakeLists.txt 2012-06-01 16:12:16.217730172 +0200
+--- vxl-1.17.0.orig/contrib/mul/vil3d/io/CMakeLists.txt 2012-06-01 15:44:00.917753578 +0200
++++ vxl-1.17.0/contrib/mul/vil3d/io/CMakeLists.txt 2012-06-01 15:44:08.993753468 +0200
@@ -7,6 +7,7 @@
)
@@ -891,10 +905,10 @@
INSTALL_TARGETS(/lib vil3d_io)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/mul/vil3d/io ${vil3d_io_sources})
TARGET_LINK_LIBRARIES( vil3d_io vil3d vil_io )
-Index: vxl/contrib/mul/vimt/algo/CMakeLists.txt
+Index: vxl-1.17.0/contrib/mul/vimt/algo/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/mul/vimt/algo/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/mul/vimt/algo/CMakeLists.txt 2012-06-01 16:12:16.217730172 +0200
+--- vxl-1.17.0.orig/contrib/mul/vimt/algo/CMakeLists.txt 2012-06-01 15:44:00.929753579 +0200
++++ vxl-1.17.0/contrib/mul/vimt/algo/CMakeLists.txt 2012-06-01 15:44:08.993753468 +0200
@@ -11,6 +11,7 @@
)
@@ -903,10 +917,10 @@
INSTALL_TARGETS(/lib vimt_algo)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/mul/vimt/algo ${vimt_algo_sources})
TARGET_LINK_LIBRARIES( vimt_algo vimt vil_algo vgl vcl )
-Index: vxl/contrib/mul/vimt/CMakeLists.txt
+Index: vxl-1.17.0/contrib/mul/vimt/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/mul/vimt/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/mul/vimt/CMakeLists.txt 2012-06-01 16:12:16.217730172 +0200
+--- vxl-1.17.0.orig/contrib/mul/vimt/CMakeLists.txt 2012-06-01 15:44:00.937753579 +0200
++++ vxl-1.17.0/contrib/mul/vimt/CMakeLists.txt 2012-06-01 15:44:08.993753468 +0200
@@ -35,6 +35,7 @@
AUX_SOURCE_DIRECTORY(Templates vimt_sources)
@@ -915,10 +929,10 @@
INSTALL_TARGETS(/lib vimt)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/mul/vimt ${vimt_sources})
TARGET_LINK_LIBRARIES(vimt mbl vil_algo vgl vnl vil_io vil )
-Index: vxl/contrib/mul/vimt3d/CMakeLists.txt
+Index: vxl-1.17.0/contrib/mul/vimt3d/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/mul/vimt3d/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/mul/vimt3d/CMakeLists.txt 2012-06-01 16:12:16.217730172 +0200
+--- vxl-1.17.0.orig/contrib/mul/vimt3d/CMakeLists.txt 2012-06-01 15:44:00.953753579 +0200
++++ vxl-1.17.0/contrib/mul/vimt3d/CMakeLists.txt 2012-06-01 15:44:08.993753468 +0200
@@ -34,6 +34,7 @@
AUX_SOURCE_DIRECTORY(Templates vimt3d_sources)
@@ -927,10 +941,10 @@
INSTALL_TARGETS(/lib vimt3d)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/mul/vimt3d ${vimt3d_sources})
TARGET_LINK_LIBRARIES(vimt3d vil3d_algo vil3d_io vil3d vimt mbl vnl_algo vgl vnl_io vnl vil vsl vul)
-Index: vxl/contrib/oul/ouel/CMakeLists.txt
+Index: vxl-1.17.0/contrib/oul/ouel/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/oul/ouel/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/oul/ouel/CMakeLists.txt 2012-06-01 16:12:16.217730172 +0200
+--- vxl-1.17.0.orig/contrib/oul/ouel/CMakeLists.txt 2012-06-01 15:44:01.785753566 +0200
++++ vxl-1.17.0/contrib/oul/ouel/CMakeLists.txt 2012-06-01 15:44:08.993753468 +0200
@@ -11,6 +11,7 @@
)
@@ -939,10 +953,10 @@
INSTALL_TARGETS(/lib ouel)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/oul/ouel ${ouel_sources})
TARGET_LINK_LIBRARIES( ouel vnl_algo vnl )
-Index: vxl/contrib/oul/oufgl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/oul/oufgl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/oul/oufgl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/oul/oufgl/CMakeLists.txt 2012-06-01 16:12:16.217730172 +0200
+--- vxl-1.17.0.orig/contrib/oul/oufgl/CMakeLists.txt 2012-06-01 15:44:01.797753567 +0200
++++ vxl-1.17.0/contrib/oul/oufgl/CMakeLists.txt 2012-06-01 15:44:08.993753468 +0200
@@ -15,6 +15,7 @@
)
@@ -951,10 +965,10 @@
INSTALL_TARGETS(/lib oufgl)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/oul/oufgl ${oufgl_sources})
TARGET_LINK_LIBRARIES( oufgl vil vil1 rt)
-Index: vxl/contrib/oul/ouml/CMakeLists.txt
+Index: vxl-1.17.0/contrib/oul/ouml/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/oul/ouml/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/oul/ouml/CMakeLists.txt 2012-06-01 16:12:16.217730172 +0200
+--- vxl-1.17.0.orig/contrib/oul/ouml/CMakeLists.txt 2012-06-01 15:44:01.809753567 +0200
++++ vxl-1.17.0/contrib/oul/ouml/CMakeLists.txt 2012-06-01 15:44:08.993753468 +0200
@@ -20,6 +20,7 @@
)
@@ -963,10 +977,10 @@
INSTALL_TARGETS(/lib ouml)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/oul/ouml ${ouml_sources})
TARGET_LINK_LIBRARIES( ouml vgl vnl_algo vnl_io vnl vil1 vsl vpl )
-Index: vxl/contrib/oxl/osl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/oxl/osl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/oxl/osl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/oxl/osl/CMakeLists.txt 2012-06-01 16:12:16.217730172 +0200
+--- vxl-1.17.0.orig/contrib/oxl/osl/CMakeLists.txt 2012-06-01 15:44:01.745753568 +0200
++++ vxl-1.17.0/contrib/oxl/osl/CMakeLists.txt 2012-06-01 15:44:08.993753468 +0200
@@ -45,6 +45,7 @@
AUX_SOURCE_DIRECTORY(Templates osl_sources)
@@ -975,10 +989,10 @@
INSTALL_TARGETS(/lib osl)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/oxl/osl ${osl_sources})
TARGET_LINK_LIBRARIES(osl vnl_algo vnl vgl vil1 vbl)
-Index: vxl/contrib/prip/vmap/CMakeLists.txt
+Index: vxl-1.17.0/contrib/prip/vmap/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/prip/vmap/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/prip/vmap/CMakeLists.txt 2012-06-01 16:12:16.217730172 +0200
+--- vxl-1.17.0.orig/contrib/prip/vmap/CMakeLists.txt 2012-06-01 15:44:00.985753577 +0200
++++ vxl-1.17.0/contrib/prip/vmap/CMakeLists.txt 2012-06-01 15:44:08.997753468 +0200
@@ -28,6 +28,7 @@
)
@@ -987,10 +1001,10 @@
INSTALL_TARGETS(/lib vmap)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/prip/vmap ${vmap_sources})
TARGET_LINK_LIBRARIES(vmap vcl)
-Index: vxl/contrib/rpl/rgrl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/rpl/rgrl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/rpl/rgrl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/rpl/rgrl/CMakeLists.txt 2012-06-01 16:12:16.217730172 +0200
+--- vxl-1.17.0.orig/contrib/rpl/rgrl/CMakeLists.txt 2012-06-01 15:44:00.789753581 +0200
++++ vxl-1.17.0/contrib/rpl/rgrl/CMakeLists.txt 2012-06-01 15:44:08.997753468 +0200
@@ -161,6 +161,7 @@
AUX_SOURCE_DIRECTORY( Templates rgrl_sources )
@@ -999,10 +1013,10 @@
INSTALL_TARGETS(/lib rgrl)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/rpl/rgrl ${rgrl_sources})
TARGET_LINK_LIBRARIES( rgrl rrel rsdl vil3d vil vnl_algo vnl vbl vul)
-Index: vxl/contrib/rpl/rgtl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/rpl/rgtl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/rpl/rgtl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/rpl/rgtl/CMakeLists.txt 2012-06-01 16:12:16.217730172 +0200
+--- vxl-1.17.0.orig/contrib/rpl/rgtl/CMakeLists.txt 2012-06-01 15:44:00.797753581 +0200
++++ vxl-1.17.0/contrib/rpl/rgtl/CMakeLists.txt 2012-06-01 15:44:08.997753468 +0200
@@ -84,6 +84,7 @@
)
@@ -1011,10 +1025,10 @@
TARGET_LINK_LIBRARIES(rgtl vnl_algo vnl vcl)
INSTALL_TARGETS(/lib rgtl)
-Index: vxl/contrib/rpl/rtvl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/rpl/rtvl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/rpl/rtvl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/rpl/rtvl/CMakeLists.txt 2012-06-01 16:12:16.217730172 +0200
+--- vxl-1.17.0.orig/contrib/rpl/rtvl/CMakeLists.txt 2012-06-01 15:44:00.813753580 +0200
++++ vxl-1.17.0/contrib/rpl/rtvl/CMakeLists.txt 2012-06-01 15:44:08.997753468 +0200
@@ -41,6 +41,7 @@
)
@@ -1023,10 +1037,10 @@
TARGET_LINK_LIBRARIES(rtvl rgtl vnl_algo vnl)
INSTALL_TARGETS(/lib rtvl)
-Index: vxl/contrib/tbl/vepl/CMakeLists.txt
+Index: vxl-1.17.0/contrib/tbl/vepl/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/tbl/vepl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/tbl/vepl/CMakeLists.txt 2012-06-01 16:12:16.217730172 +0200
+--- vxl-1.17.0.orig/contrib/tbl/vepl/CMakeLists.txt 2012-06-01 15:44:01.769753566 +0200
++++ vxl-1.17.0/contrib/tbl/vepl/CMakeLists.txt 2012-06-01 15:44:08.997753468 +0200
@@ -52,6 +52,7 @@
ENDIF(CMAKE_COMPILER_IS_GNUCXX)
@@ -1035,10 +1049,10 @@
INSTALL_TARGETS(/lib vepl)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/contrib/tbl/vepl ${vepl_sources})
TARGET_LINK_LIBRARIES(vepl vipl vil ${CMAKE_THREAD_LIBS})
-Index: vxl/core/testlib/CMakeLists.txt
+Index: vxl-1.17.0/core/testlib/CMakeLists.txt
===================================================================
---- vxl.orig/core/testlib/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/core/testlib/CMakeLists.txt 2012-06-01 16:12:16.221730172 +0200
+--- vxl-1.17.0.orig/core/testlib/CMakeLists.txt 2012-06-01 15:44:01.881753566 +0200
++++ vxl-1.17.0/core/testlib/CMakeLists.txt 2012-06-01 15:44:08.997753468 +0200
@@ -29,6 +29,7 @@
)
@@ -1047,10 +1061,10 @@
TARGET_LINK_LIBRARIES( testlib vcl )
INSTALL_TARGETS( /lib testlib)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/core/testlib ${testlib_sources})
-Index: vxl/core/vbl/CMakeLists.txt
+Index: vxl-1.17.0/core/vbl/CMakeLists.txt
===================================================================
---- vxl.orig/core/vbl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/core/vbl/CMakeLists.txt 2012-06-01 16:12:16.221730172 +0200
+--- vxl-1.17.0.orig/core/vbl/CMakeLists.txt 2012-06-01 15:44:01.889753566 +0200
++++ vxl-1.17.0/core/vbl/CMakeLists.txt 2012-06-01 15:44:08.997753468 +0200
@@ -42,6 +42,7 @@
AUX_SOURCE_DIRECTORY(Templates vbl_sources)
@@ -1059,10 +1073,10 @@
TARGET_LINK_LIBRARIES( vbl vcl )
INSTALL_TARGETS(/lib vbl)
-Index: vxl/core/vbl/io/CMakeLists.txt
+Index: vxl-1.17.0/core/vbl/io/CMakeLists.txt
===================================================================
---- vxl.orig/core/vbl/io/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/core/vbl/io/CMakeLists.txt 2012-06-01 16:12:16.221730172 +0200
+--- vxl-1.17.0.orig/core/vbl/io/CMakeLists.txt 2012-06-01 15:44:01.897753566 +0200
++++ vxl-1.17.0/core/vbl/io/CMakeLists.txt 2012-06-01 15:44:08.997753468 +0200
@@ -17,6 +17,7 @@
AUX_SOURCE_DIRECTORY(Templates vbl_io_sources)
@@ -1071,10 +1085,10 @@
TARGET_LINK_LIBRARIES( vbl_io vbl vsl )
INSTALL_TARGETS(/lib vbl_io)
-Index: vxl/core/vcsl/CMakeLists.txt
+Index: vxl-1.17.0/core/vcsl/CMakeLists.txt
===================================================================
---- vxl.orig/core/vcsl/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/core/vcsl/CMakeLists.txt 2012-06-01 16:12:16.221730172 +0200
+--- vxl-1.17.0.orig/core/vcsl/CMakeLists.txt 2012-06-01 15:44:01.909753564 +0200
++++ vxl-1.17.0/core/vcsl/CMakeLists.txt 2012-06-01 15:44:08.997753468 +0200
@@ -63,6 +63,7 @@
AUX_SOURCE_DIRECTORY( Templates vcsl_sources )
@@ -1083,10 +1097,10 @@
TARGET_LINK_LIBRARIES( vcsl vnl vbl )
INSTALL_TARGETS(/lib vcsl)
-Index: vxl/core/vgl/CMakeLists.txt
+Index: vxl-1.17.0/core/vgl/CMakeLists.txt
===================================================================
---- vxl.orig/core/vgl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/core/vgl/CMakeLists.txt 2012-06-01 16:12:16.221730172 +0200
+--- vxl-1.17.0.orig/core/vgl/CMakeLists.txt 2012-06-01 15:44:01.829753566 +0200
++++ vxl-1.17.0/core/vgl/CMakeLists.txt 2012-06-01 15:44:08.997753468 +0200
@@ -69,6 +69,7 @@
AUX_SOURCE_DIRECTORY(Templates vgl_sources)
@@ -1095,10 +1109,10 @@
TARGET_LINK_LIBRARIES( vgl vcl )
doxygen_add_library(core/vgl
#DEPENDS core/vsl core/vnl
-Index: vxl/core/vgl/io/CMakeLists.txt
+Index: vxl-1.17.0/core/vgl/io/CMakeLists.txt
===================================================================
---- vxl.orig/core/vgl/io/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/core/vgl/io/CMakeLists.txt 2012-06-01 16:12:16.221730172 +0200
+--- vxl-1.17.0.orig/core/vgl/io/CMakeLists.txt 2012-06-01 15:44:01.841753565 +0200
++++ vxl-1.17.0/core/vgl/io/CMakeLists.txt 2012-06-01 15:44:08.997753468 +0200
@@ -29,6 +29,7 @@
AUX_SOURCE_DIRECTORY(Templates vgl_io_sources)
@@ -1107,10 +1121,10 @@
TARGET_LINK_LIBRARIES( vgl_io vgl vsl )
INSTALL_TARGETS(/lib vgl_io)
-Index: vxl/core/vgui/CMakeLists.txt
+Index: vxl-1.17.0/core/vgui/CMakeLists.txt
===================================================================
---- vxl.orig/core/vgui/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/core/vgui/CMakeLists.txt 2012-06-01 16:12:16.221730172 +0200
+--- vxl-1.17.0.orig/core/vgui/CMakeLists.txt 2012-06-01 15:44:01.917753564 +0200
++++ vxl-1.17.0/core/vgui/CMakeLists.txt 2012-06-01 15:44:09.001753467 +0200
@@ -518,6 +518,7 @@
)
@@ -1119,10 +1133,10 @@
INSTALL_TARGETS(/lib vgui)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/core/vgui ${vgui_sources})
SET( VGUI_FOUND "YES" CACHE INTERNAL "Was vgui successfully built?" )
-Index: vxl/core/vgui/wx/CMakeLists.txt
+Index: vxl-1.17.0/core/vgui/wx/CMakeLists.txt
===================================================================
---- vxl.orig/core/vgui/wx/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/core/vgui/wx/CMakeLists.txt 2012-06-01 16:12:16.221730172 +0200
+--- vxl-1.17.0.orig/core/vgui/wx/CMakeLists.txt 2012-06-01 15:44:01.929753564 +0200
++++ vxl-1.17.0/core/vgui/wx/CMakeLists.txt 2012-06-01 15:44:09.001753467 +0200
@@ -24,6 +24,7 @@
)
@@ -1131,10 +1145,10 @@
TARGET_LINK_LIBRARIES(vgui_wx vgui ${wxWidgets_LIBRARIES})
IF (BUILD_TESTING)
-Index: vxl/core/vidl/CMakeLists.txt
+Index: vxl-1.17.0/core/vidl/CMakeLists.txt
===================================================================
---- vxl.orig/core/vidl/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/core/vidl/CMakeLists.txt 2012-06-01 16:12:16.221730172 +0200
+--- vxl-1.17.0.orig/core/vidl/CMakeLists.txt 2012-06-01 15:44:01.937753565 +0200
++++ vxl-1.17.0/core/vidl/CMakeLists.txt 2012-06-01 15:44:09.001753467 +0200
@@ -128,6 +128,7 @@
AUX_SOURCE_DIRECTORY(Templates vidl_sources)
@@ -1143,10 +1157,10 @@
INSTALL_TARGETS(/lib vidl)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/core/vidl ${vidl_sources})
-Index: vxl/core/vidl/gui/CMakeLists.txt
+Index: vxl-1.17.0/core/vidl/gui/CMakeLists.txt
===================================================================
---- vxl.orig/core/vidl/gui/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/core/vidl/gui/CMakeLists.txt 2012-06-01 16:12:16.221730172 +0200
+--- vxl-1.17.0.orig/core/vidl/gui/CMakeLists.txt 2012-06-01 15:44:01.945753565 +0200
++++ vxl-1.17.0/core/vidl/gui/CMakeLists.txt 2012-06-01 15:44:09.001753467 +0200
@@ -12,6 +12,7 @@
)
@@ -1155,10 +1169,10 @@
INSTALL_TARGETS(/lib vidl_gui)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/core/vidl/gui ${vidl_gui_sources})
TARGET_LINK_LIBRARIES( vidl_gui vidl vgui vil )
-Index: vxl/core/vil/algo/CMakeLists.txt
+Index: vxl-1.17.0/core/vil/algo/CMakeLists.txt
===================================================================
---- vxl.orig/core/vil/algo/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/core/vil/algo/CMakeLists.txt 2012-06-01 16:12:16.221730172 +0200
+--- vxl-1.17.0.orig/core/vil/algo/CMakeLists.txt 2012-06-01 15:44:01.961753565 +0200
++++ vxl-1.17.0/core/vil/algo/CMakeLists.txt 2012-06-01 15:44:09.001753467 +0200
@@ -57,6 +57,7 @@
AUX_SOURCE_DIRECTORY(Templates vil_algo_sources)
@@ -1167,10 +1181,10 @@
TARGET_LINK_LIBRARIES( vil_algo vil vnl_algo vnl vcl )
-Index: vxl/core/vil/CMakeLists.txt
+Index: vxl-1.17.0/core/vil/CMakeLists.txt
===================================================================
---- vxl.orig/core/vil/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/core/vil/CMakeLists.txt 2012-06-01 16:12:16.221730172 +0200
+--- vxl-1.17.0.orig/core/vil/CMakeLists.txt 2012-06-01 15:44:01.969753565 +0200
++++ vxl-1.17.0/core/vil/CMakeLists.txt 2012-06-01 15:44:09.001753467 +0200
@@ -340,6 +340,7 @@
TARGET_LINK_LIBRARIES( vil nsl vil_network socket )
ENDIF (SOLARIS)
@@ -1179,10 +1193,10 @@
INSTALL_NOBASE_HEADER_FILES(/include/vxl/core/vil
${vil_sources}
${vil_network_sources}
-Index: vxl/core/vil/io/CMakeLists.txt
+Index: vxl-1.17.0/core/vil/io/CMakeLists.txt
===================================================================
---- vxl.orig/core/vil/io/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/core/vil/io/CMakeLists.txt 2012-06-01 16:12:16.221730172 +0200
+--- vxl-1.17.0.orig/core/vil/io/CMakeLists.txt 2012-06-01 15:44:01.977753563 +0200
++++ vxl-1.17.0/core/vil/io/CMakeLists.txt 2012-06-01 15:44:09.001753467 +0200
@@ -15,6 +15,7 @@
ENDIF(CMAKE_COMPILER_IS_GNUCXX)
@@ -1191,10 +1205,10 @@
TARGET_LINK_LIBRARIES( vil_io vil vsl )
INSTALL_TARGETS(/lib vil_io)
-Index: vxl/core/vil1/CMakeLists.txt
+Index: vxl-1.17.0/core/vil1/CMakeLists.txt
===================================================================
---- vxl.orig/core/vil1/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/core/vil1/CMakeLists.txt 2012-06-01 16:12:16.221730172 +0200
+--- vxl-1.17.0.orig/core/vil1/CMakeLists.txt 2012-06-01 15:44:01.985753563 +0200
++++ vxl-1.17.0/core/vil1/CMakeLists.txt 2012-06-01 15:44:09.001753467 +0200
@@ -169,6 +169,7 @@
ENDIF(CMAKE_COMPILER_IS_GNUCXX)
@@ -1203,10 +1217,10 @@
INSTALL_TARGETS(/lib vil1)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/core/vil1 ${vil1_sources})
-Index: vxl/core/vil1/io/CMakeLists.txt
+Index: vxl-1.17.0/core/vil1/io/CMakeLists.txt
===================================================================
---- vxl.orig/core/vil1/io/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/core/vil1/io/CMakeLists.txt 2012-06-01 16:12:16.221730172 +0200
+--- vxl-1.17.0.orig/core/vil1/io/CMakeLists.txt 2012-06-01 15:44:01.997753563 +0200
++++ vxl-1.17.0/core/vil1/io/CMakeLists.txt 2012-06-01 15:44:09.001753467 +0200
@@ -15,6 +15,7 @@
AUX_SOURCE_DIRECTORY(Templates vil1_io_sources)
@@ -1215,10 +1229,10 @@
TARGET_LINK_LIBRARIES( vil1_io vil1 vsl )
INSTALL_TARGETS(/lib vil1_io)
INSTALL_NOBASE_HEADER_FILES(/include/vxl/core/vil1/io ${vil1_io_sources})
-Index: vxl/core/vnl/algo/CMakeLists.txt
+Index: vxl-1.17.0/core/vnl/algo/CMakeLists.txt
===================================================================
---- vxl.orig/core/vnl/algo/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/core/vnl/algo/CMakeLists.txt 2012-06-01 16:12:16.221730172 +0200
+--- vxl-1.17.0.orig/core/vnl/algo/CMakeLists.txt 2012-06-01 15:44:02.009753564 +0200
++++ vxl-1.17.0/core/vnl/algo/CMakeLists.txt 2012-06-01 15:44:09.001753467 +0200
@@ -102,6 +102,7 @@
AUX_SOURCE_DIRECTORY(Templates vnl_algo_sources)
@@ -1227,10 +1241,10 @@
TARGET_LINK_LIBRARIES( vnl_algo ${NETLIB_LIBRARIES} vnl )
INSTALL_TARGETS(/lib vnl_algo)
-Index: vxl/core/vnl/CMakeLists.txt
+Index: vxl-1.17.0/core/vnl/CMakeLists.txt
===================================================================
---- vxl.orig/core/vnl/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/core/vnl/CMakeLists.txt 2012-06-01 16:12:16.221730172 +0200
+--- vxl-1.17.0.orig/core/vnl/CMakeLists.txt 2012-06-01 15:44:02.021753564 +0200
++++ vxl-1.17.0/core/vnl/CMakeLists.txt 2012-06-01 15:44:09.001753467 +0200
@@ -264,6 +264,7 @@
ENDIF(CMAKE_COMPILER_IS_GNUCXX)
@@ -1239,10 +1253,10 @@
TARGET_LINK_LIBRARIES( vnl vcl )
INSTALL_TARGETS(/lib vnl)
-Index: vxl/core/vnl/io/CMakeLists.txt
+Index: vxl-1.17.0/core/vnl/io/CMakeLists.txt
===================================================================
---- vxl.orig/core/vnl/io/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/core/vnl/io/CMakeLists.txt 2012-06-01 16:12:16.221730172 +0200
+--- vxl-1.17.0.orig/core/vnl/io/CMakeLists.txt 2012-06-01 15:44:02.029753564 +0200
++++ vxl-1.17.0/core/vnl/io/CMakeLists.txt 2012-06-01 15:44:09.001753467 +0200
@@ -26,6 +26,7 @@
ENDIF(CMAKE_COMPILER_IS_GNUCXX)
@@ -1251,10 +1265,10 @@
TARGET_LINK_LIBRARIES( vnl_io vnl vsl )
INSTALL_TARGETS(/lib vnl_io)
-Index: vxl/core/vnl/xio/CMakeLists.txt
+Index: vxl-1.17.0/core/vnl/xio/CMakeLists.txt
===================================================================
---- vxl.orig/core/vnl/xio/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/core/vnl/xio/CMakeLists.txt 2012-06-01 16:12:16.225730172 +0200
+--- vxl-1.17.0.orig/core/vnl/xio/CMakeLists.txt 2012-06-01 15:44:02.041753564 +0200
++++ vxl-1.17.0/core/vnl/xio/CMakeLists.txt 2012-06-01 15:44:09.001753467 +0200
@@ -11,6 +11,7 @@
AUX_SOURCE_DIRECTORY(Templates vnl_xio_sources)
@@ -1263,10 +1277,10 @@
TARGET_LINK_LIBRARIES( vnl_xio vnl vsl )
INSTALL_TARGETS(/lib vnl_xio)
-Index: vxl/core/vpdl/CMakeLists.txt
+Index: vxl-1.17.0/core/vpdl/CMakeLists.txt
===================================================================
---- vxl.orig/core/vpdl/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/core/vpdl/CMakeLists.txt 2012-06-01 16:12:16.225730172 +0200
+--- vxl-1.17.0.orig/core/vpdl/CMakeLists.txt 2012-06-01 15:44:02.053753562 +0200
++++ vxl-1.17.0/core/vpdl/CMakeLists.txt 2012-06-01 15:44:09.001753467 +0200
@@ -48,6 +48,7 @@
AUX_SOURCE_DIRECTORY(Templates vpdl_sources)
@@ -1275,10 +1289,10 @@
TARGET_LINK_LIBRARIES( vpdl vnl_algo vnl )
INSTALL_TARGETS(/lib vpdl)
-Index: vxl/core/vsl/CMakeLists.txt
+Index: vxl-1.17.0/core/vsl/CMakeLists.txt
===================================================================
---- vxl.orig/core/vsl/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/core/vsl/CMakeLists.txt 2012-06-01 16:12:16.225730172 +0200
+--- vxl-1.17.0.orig/core/vsl/CMakeLists.txt 2012-06-01 15:44:02.073753562 +0200
++++ vxl-1.17.0/core/vsl/CMakeLists.txt 2012-06-01 15:44:09.005753466 +0200
@@ -36,6 +36,7 @@
AUX_SOURCE_DIRECTORY(Templates vsl_sources)
@@ -1287,10 +1301,10 @@
TARGET_LINK_LIBRARIES( vsl vcl )
INSTALL_TARGETS(/lib vsl)
-Index: vxl/core/vul/io/CMakeLists.txt
+Index: vxl-1.17.0/core/vul/io/CMakeLists.txt
===================================================================
---- vxl.orig/core/vul/io/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/core/vul/io/CMakeLists.txt 2012-06-01 16:12:16.225730172 +0200
+--- vxl-1.17.0.orig/core/vul/io/CMakeLists.txt 2012-06-01 15:44:01.873753566 +0200
++++ vxl-1.17.0/core/vul/io/CMakeLists.txt 2012-06-01 15:44:09.005753466 +0200
@@ -5,6 +5,7 @@
)
@@ -1299,10 +1313,10 @@
TARGET_LINK_LIBRARIES(vul_io vul vsl)
INSTALL_TARGETS(/lib vul_io)
-Index: vxl/v3p/dcmtk/CMakeLists.txt
+Index: vxl-1.17.0/v3p/dcmtk/CMakeLists.txt
===================================================================
---- vxl.orig/v3p/dcmtk/CMakeLists.txt 2012-06-01 16:11:14.000000000 +0200
-+++ vxl/v3p/dcmtk/CMakeLists.txt 2012-06-01 16:12:16.225730172 +0200
+--- vxl-1.17.0.orig/v3p/dcmtk/CMakeLists.txt 2012-06-01 15:44:00.757753580 +0200
++++ vxl-1.17.0/v3p/dcmtk/CMakeLists.txt 2012-06-01 15:44:09.005753466 +0200
@@ -453,6 +453,7 @@
TARGET_LINK_LIBRARIES( dcmtk ${ZLIB_LIBRARIES} )
ENDIF( DCMTK_HAVE_ZLIB )
@@ -1311,10 +1325,10 @@
INSTALL_TARGETS( /lib dcmtk )
IF( BUILD_TESTING )
-Index: vxl/vcl/CMakeLists.txt
+Index: vxl-1.17.0/vcl/CMakeLists.txt
===================================================================
---- vxl.orig/vcl/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/vcl/CMakeLists.txt 2012-06-01 16:12:16.225730172 +0200
+--- vxl-1.17.0.orig/vcl/CMakeLists.txt 2012-06-01 15:44:02.085753563 +0200
++++ vxl-1.17.0/vcl/CMakeLists.txt 2012-06-01 15:44:09.005753466 +0200
@@ -360,6 +360,7 @@
#AUX_SOURCE_DIRECTORY(Templates vcl_sources)
@@ -1323,10 +1337,10 @@
# CMake can automatically figure out the compiler characteristics on
# Windows too. No need to do manual config.
-Index: vxl/contrib/brl/b3p/expatpp/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/b3p/expatpp/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/b3p/expatpp/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/b3p/expatpp/CMakeLists.txt 2012-06-01 16:12:16.225730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/b3p/expatpp/CMakeLists.txt 2012-06-01 15:44:01.277753573 +0200
++++ vxl-1.17.0/contrib/brl/b3p/expatpp/CMakeLists.txt 2012-06-01 15:44:09.005753466 +0200
@@ -12,6 +12,9 @@
SET( expatpp_sources expatpp.h expatpp.cpp expatpplib.h )
@@ -1337,10 +1351,10 @@
TARGET_LINK_LIBRARIES( expatpp ${EXPAT_LIBRARIES} )
IF( BUILD_TESTING )
-Index: vxl/contrib/brl/bbas/bxml/bsvg/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bxml/bsvg/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bxml/bsvg/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bxml/bsvg/CMakeLists.txt 2012-06-01 16:12:16.225730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/bxml/bsvg/CMakeLists.txt 2012-06-01 15:44:01.229753575 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bxml/bsvg/CMakeLists.txt 2012-06-01 15:44:09.005753466 +0200
@@ -12,7 +12,9 @@
AUX_SOURCE_DIRECTORY(Templates bsvg_sources)
@@ -1352,10 +1366,10 @@
TARGET_LINK_LIBRARIES( bsvg bxml )
IF( BUILD_TESTING )
-Index: vxl/contrib/brl/bbas/bmsh3d/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/bmsh3d/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/bmsh3d/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/bmsh3d/CMakeLists.txt 2012-06-01 16:12:16.225730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/bmsh3d/CMakeLists.txt 2012-06-01 15:44:01.105753576 +0200
++++ vxl-1.17.0/contrib/brl/bbas/bmsh3d/CMakeLists.txt 2012-06-01 15:44:09.005753466 +0200
@@ -32,7 +32,9 @@
)
@@ -1367,10 +1381,10 @@
TARGET_LINK_LIBRARIES( bmsh3d vgl vgl_algo vnl vul)
SUBDIRS( algo )
-Index: vxl/contrib/brl/bpro/bprb/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bpro/bprb/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bpro/bprb/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bpro/bprb/CMakeLists.txt 2012-06-01 16:12:16.225730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bpro/bprb/CMakeLists.txt 2012-06-01 15:44:01.353753572 +0200
++++ vxl-1.17.0/contrib/brl/bpro/bprb/CMakeLists.txt 2012-06-01 15:44:09.005753466 +0200
@@ -18,7 +18,9 @@
AUX_SOURCE_DIRECTORY(Templates bprb_sources)
@@ -1382,10 +1396,10 @@
TARGET_LINK_LIBRARIES(bprb brdb bxml vbl vsl)
IF(BUILD_TESTING)
-Index: vxl/contrib/brl/bbas/brdb/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bbas/brdb/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bbas/brdb/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bbas/brdb/CMakeLists.txt 2012-06-01 16:12:16.225730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bbas/brdb/CMakeLists.txt 2012-06-01 15:44:01.257753573 +0200
++++ vxl-1.17.0/contrib/brl/bbas/brdb/CMakeLists.txt 2012-06-01 15:44:09.005753466 +0200
@@ -15,7 +15,9 @@
AUX_SOURCE_DIRECTORY(Templates brdb_sources)
@@ -1397,10 +1411,10 @@
# brdb should not depend on any library that uses it
TARGET_LINK_LIBRARIES(brdb vbl_io vbl vsl)
-Index: vxl/contrib/brl/bseg/boct/CMakeLists.txt
+Index: vxl-1.17.0/contrib/brl/bseg/boct/CMakeLists.txt
===================================================================
---- vxl.orig/contrib/brl/bseg/boct/CMakeLists.txt 2012-06-01 16:11:13.000000000 +0200
-+++ vxl/contrib/brl/bseg/boct/CMakeLists.txt 2012-06-01 16:12:16.225730172 +0200
+--- vxl-1.17.0.orig/contrib/brl/bseg/boct/CMakeLists.txt 2012-06-01 15:44:01.545753569 +0200
++++ vxl-1.17.0/contrib/brl/bseg/boct/CMakeLists.txt 2012-06-01 15:44:09.005753466 +0200
@@ -14,7 +14,9 @@
AUX_SOURCE_DIRECTORY(Templates boct_sources)
More information about the debian-med-commit
mailing list