int main() { load("./txt/train.txt", train_literals, train_clicks, true); load("./txt/test.txt", test_literals, test_clicks, false); load_dictionary("./txt/punctuation.txt", dictionary); save_vector("./txt/train_punctuation.txt", train_literals, dictionary); save_vector("./txt/test_punctuation.txt", test_literals, dictionary); save_label("./txt/train_label.txt", train_clicks); save_label("./txt/test_label.txt", test_clicks); return 0; }
void main() { int i; float svector[3] = {0.1, -0.345, 7.3}; float *dvector; float sloadvector[3]; float *dloadvector; int dim = 3; int dloaddim=0; dvector = (float *)malloc(3 * sizeof(float)); dvector[0] = 0.1; dvector[1] = -0.345; dvector[2] = 7.3; save_vector(svector, "sbinary.mat", dim); save_ascii_vector(svector, "sascii.mat", dim); save_packed_vector(svector, "spacked.mat", dim); save_vector(dvector, "dbinary.mat", dim); save_ascii_vector(dvector, "dascii.mat", dim); save_packed_vector(dvector, "dpacked.mat", dim); printf("saved 6 vectors\n"); dloadvector = load_vector("dbinary.mat", &dloaddim); printf("loaded vector of length %d\n", dloaddim); for(i=0; i<3; i++) printf("%4.2f ", dloadvector[i]); printf ("\n"); load_in_vector(sloadvector, "dascii.mat", dim); printf("loaded vector of length %d\n", dim); for(i=0; i<3; i++) printf("%4.2f ", sloadvector[i]); printf ("\n"); dloadvector = load_vector("dpacked.mat", &dloaddim); printf("loaded vector of length %d\n", dloaddim); for(i=0; i<3; i++) printf("%4.2f ", dloadvector[i]); printf ("\n"); load_in_vector(sloadvector, "dbinary.mat", dim); printf("loaded vector of length %d\n", dim); for(i=0; i<3; i++) printf("%4.2f ", sloadvector[i]); printf ("\n"); dloadvector = load_vector("dascii.mat", &dloaddim); printf("loaded vector of length %d\n", dloaddim); for(i=0; i<3; i++) printf("%4.2f ", dloadvector[i]); printf ("\n"); load_in_vector(sloadvector, "dpacked.mat", dim); printf("loaded vector of length %d\n", dim); for(i=0; i<3; i++) printf("%4.2f ", sloadvector[i]); printf ("\ndone.\n"); }
void save(Archive& ar, const unsigned Integer) const { save_sparse_matrix(ar, reduce_A_); save_vector(ar, W_); ar & R_; ar & G_; ar & C_; ar & ins_; ar & iter_; ar & time_; }
int main(int argc, char** argv){ unsigned int N = 200; int n; gsl_vector *hare = gsl_vector_alloc(N); gsl_vector *lynx = gsl_vector_alloc(N); gsl_vector *t = gsl_vector_alloc(N); //Set up system parameters double h = 0.1; double alpha = 2; double x = 1; double y = 0.1; //Solve system for(n=0; n<N; n++){ x = x + h*(1-y)*x; y = y + h*alpha*(x-1)*y; //Store result gsl_vector_set(hare, n, x); gsl_vector_set(lynx, n, y); gsl_vector_set(t, n, n); } //Write to file save_vector(hare, "hare.txt"); save_vector(lynx, "lynx.txt"); save_vector(t, "time.txt"); //Free memory gsl_vector_free(hare); gsl_vector_free(lynx); gsl_vector_free(t); return EXIT_SUCCESS; }
int main(int argc, char* argv[]) { if(argc!=5){ fprintf(stderr,"USAGE:\n\t%s <input file> <num steps> <output file> <max number of threads> \n", argv[0]); fprintf(stderr, "EXAMPLE:\n\t%s random.txt 500 result.txt 8\n", argv[0]); exit(EXIT_FAILURE); } char* init_fname = argv[1]; sscanf(argv[2],"%d", &steps); char* out_fname = argv[3]; int max_n_threads = atoi(argv[4]); long time_vs_threads[max_n_threads+1]; int tmp[max_n_threads]; threads_arg=tmp; char** init_matrix = dump_matrix_file(init_fname); char** zero_matrix = allocate_matrix(width, height); matrix_from = allocate_matrix(width, height); matrix_to = allocate_matrix(width, height); // run by different number of threads, and measure the time for(n_threads=1; n_threads <= max_n_threads; n_threads++){ copy_matrix(init_matrix, matrix_from, width+2, height+2); copy_matrix(zero_matrix, matrix_to, width+2, height+2); time_vs_threads[n_threads] = walltime_of_threads(n_threads); printf("walltime when run by %d threads: %d microseconds\n", n_threads, time_vs_threads[n_threads]); } save_matrix_file(out_fname, matrix_from,width,height); char time_fname[20]; sprintf(time_fname,"time-%d-%d.txt",width,height); save_vector(time_fname, time_vs_threads+1, max_n_threads); free_matrix(zero_matrix,width,height); free_matrix(init_matrix,width,height); free_matrix(matrix_from,width,height); free_matrix(matrix_to,width,height); return 0; }
int main() { load("../txt/literal.txt", literals); load_dictionary("../txt/punctuation.txt", dictionary); save_vector("../txt/vector_punctuation.txt", literals, dictionary); return 0; }
int main(int argc, char **argv) { ref_vector X, B, Bi; vector C, C1; comp_vector S, Si, Scomp, Scompi; comp_vector R, Ri, Rcomp, Rcompi; comp_matrix O, Oi; int s_ratio; exome ex; check_syntax(argc, 5, "preprocess_debug ref_file output_dir s_ratio nucleotides"); timevars(); init_replace_table(argv[4]); s_ratio = atoi(argv[3]); encode_reference(&X, &ex, true, argv[1]); save_exome_file(&ex, argv[2]); tic("Calculating BWT"); calculateBWTdebug(&B, &S, &X, 0); toc(); save_ref_vector(&X, argv[2], "X"); print_vector(S.vector, S.n); print_vector(B.vector, B.n); tic("Calculating prefix-trie matrices C and O"); calculate_C(&C, &C1, &B); calculate_O(&O, &B); toc(); print_vector(C.vector, C.n); print_vector(C1.vector, C1.n); print_comp_matrix(O); save_ref_vector(&B, argv[2], "B"); free(B.vector); save_vector(&C, argv[2], "C"); free(C.vector); save_vector(&C1, argv[2], "C1"); free(C1.vector); save_comp_matrix(&O, argv[2], "O"); free_comp_matrix(NULL, &O); tic("Calculating R"); calculate_R(&R, &S); toc(); print_vector(R.vector, R.n); tic("Calculating Scomp Rcomp"); compress_SR(&S, &Scomp, s_ratio); print_vector(Scomp.vector, Scomp.n); compress_SR(&R, &Rcomp, s_ratio); print_vector(Rcomp.vector, Rcomp.n); toc(); save_comp_vector(&S, argv[2], "S"); free(S.vector); save_comp_vector(&R, argv[2], "R"); free(R.vector); save_comp_vector(&Scomp, argv[2], "Scomp"); free(Scomp.vector); save_comp_vector(&Rcomp, argv[2], "Rcomp"); free(Rcomp.vector); tic("Calculating BWT of reverse reference"); calculateBWTdebug(&Bi, &Si, &X, 1); toc(); save_ref_vector(&X, argv[2], "Xi"); print_vector(Bi.vector, Bi.n); print_vector(Si.vector, Si.n); tic("Calculating inverted prefix-trie matrix Oi"); calculate_O(&Oi, &Bi); toc(); free(X.vector); print_comp_matrix(Oi); save_ref_vector(&Bi, argv[2], "Bi"); free(Bi.vector); save_comp_matrix(&Oi, argv[2], "Oi"); free_comp_matrix(NULL, &Oi); tic("Calculating Ri"); calculate_R(&Ri, &Si); toc(); print_vector(Ri.vector, Ri.n); tic("Calculating Scompi Rcompi"); compress_SR(&Si, &Scompi, s_ratio); print_vector(Scompi.vector, Scompi.n); compress_SR(&Ri, &Rcompi, s_ratio); print_vector(Rcompi.vector, Rcompi.n); toc(); save_comp_vector(&Si, argv[2], "Si"); free(Si.vector); save_comp_vector(&Ri, argv[2], "Ri"); free(Ri.vector); save_comp_vector(&Scompi, argv[2], "Scompi"); free(Scompi.vector); save_comp_vector(&Rcompi, argv[2], "Rcompi"); free(Rcompi.vector); return 0; }
int main(int argc, char **argv) { struct GModule *module; struct Option *voutput_opt, *routput_opt, *color_output_opt, *ply_opt, *zrange_opt, *trim_opt, *rotate_Z_opt, *smooth_radius_opt, *region_opt, *raster_opt, *zexag_opt, *resolution_opt, *method_opt, *calib_matrix_opt, *numscan_opt, *trim_tolerance_opt, *contours_map, *contours_step_opt, *draw_opt, *draw_vector_opt, *draw_threshold_opt; struct Flag *loop_flag, *calib_flag, *equalize_flag; struct Map_info Map; struct line_pnts *Points; struct line_cats *Cats; int cat = 1; G_gisinit(argv[0]); module = G_define_module(); G_add_keyword(_("vector")); G_add_keyword(_("scan")); G_add_keyword(_("points")); module->label = _("Imports a point cloud from Kinect v2"); module->description = _("Imports a point cloud from Kinect v2"); routput_opt = G_define_standard_option(G_OPT_R_OUTPUT); routput_opt->guisection = _("Output"); routput_opt->required = NO; resolution_opt = G_define_option(); resolution_opt->key = "resolution"; resolution_opt->type = TYPE_DOUBLE; resolution_opt->required = NO; resolution_opt->answer = "0.002"; resolution_opt->label = _("Raster resolution"); resolution_opt->description = _("Recommended values between 0.001-0.003"); resolution_opt->guisection = _("Output"); color_output_opt = G_define_standard_option(G_OPT_R_BASENAME_OUTPUT); color_output_opt->key = "color_output"; color_output_opt->description = _("Basename for color output"); color_output_opt->guisection = _("Output"); color_output_opt->required = NO; voutput_opt = G_define_standard_option(G_OPT_V_OUTPUT); voutput_opt->required = NO; voutput_opt->key = "vector"; voutput_opt->guisection = _("Output"); ply_opt = G_define_standard_option(G_OPT_F_OUTPUT); ply_opt->required = NO; ply_opt->key = "ply"; ply_opt->description = _("Name of output binary PLY file"); ply_opt->guisection = _("Output"); zrange_opt = G_define_option(); zrange_opt->key = "zrange"; zrange_opt->type = TYPE_DOUBLE; zrange_opt->required = NO; zrange_opt->key_desc = "min,max"; zrange_opt->label = _("Filter range for z data (min,max)"); zrange_opt->description = _("Z is distance from scanner in cm"); zrange_opt->guisection = _("Filter"); trim_opt = G_define_option(); trim_opt->key = "trim"; trim_opt->type = TYPE_DOUBLE; trim_opt->required = NO; trim_opt->key_desc = "N,S,E,W"; trim_opt->description = _("Clip box from center in cm"); trim_opt->guisection = _("Filter"); trim_tolerance_opt = G_define_option(); trim_tolerance_opt->key = "trim_tolerance"; trim_tolerance_opt->type = TYPE_DOUBLE; trim_tolerance_opt->required = NO; trim_tolerance_opt->description = _("Influences how much are model sides trimmed automatically, " " should be higher for rectangular models"); trim_tolerance_opt->label = _("Trim tolerance between 0 and 1"); trim_tolerance_opt->options = "0-1"; trim_tolerance_opt->guisection = _("Filter"); rotate_Z_opt = G_define_option(); rotate_Z_opt->key = "rotate"; rotate_Z_opt->type = TYPE_DOUBLE; rotate_Z_opt->required = NO; rotate_Z_opt->answer = "0"; rotate_Z_opt->description = _("Rotate along Z axis"); rotate_Z_opt->guisection = _("Georeferencing"); smooth_radius_opt = G_define_option(); smooth_radius_opt->key = "smooth_radius"; smooth_radius_opt->type = TYPE_DOUBLE; smooth_radius_opt->required = NO; smooth_radius_opt->label = _("Smooth radius"); smooth_radius_opt->description = _("Recommended values between 0.006-0.009"); region_opt = G_define_option(); region_opt->key = "region"; region_opt->key_desc = "name"; region_opt->required = NO; region_opt->multiple = NO; region_opt->type = TYPE_STRING; region_opt->description = _("Region of the resulting raster"); region_opt->gisprompt = "old,windows,region"; region_opt->guisection = _("Georeferencing"); raster_opt = G_define_standard_option(G_OPT_R_MAP); raster_opt->key = "raster"; raster_opt->required = NO; raster_opt->multiple = NO; raster_opt->description = _("Match resulting raster to this raster map"); raster_opt->guisection = _("Georeferencing"); zexag_opt = G_define_option(); zexag_opt->key = "zexag"; zexag_opt->type = TYPE_DOUBLE; zexag_opt->required = NO; zexag_opt->required = NO; zexag_opt->answer = "1"; zexag_opt->description = _("Vertical exaggeration"); zexag_opt->guisection = _("Georeferencing"); method_opt = G_define_option(); method_opt->key = "method"; method_opt->multiple = NO; method_opt->required = NO; method_opt->type = TYPE_STRING; method_opt->options = "interpolation,mean,min,max"; method_opt->answer = "mean"; method_opt->description = _("Surface reconstruction method"); calib_matrix_opt = G_define_option(); calib_matrix_opt->key = "calib_matrix"; calib_matrix_opt->multiple = YES; calib_matrix_opt->type = TYPE_DOUBLE; calib_matrix_opt->required = NO; calib_matrix_opt->description = _("Calibration matrix"); calib_matrix_opt->guisection = _("Calibration"); numscan_opt = G_define_option(); numscan_opt->answer = "1"; numscan_opt->key = "numscan"; numscan_opt->type = TYPE_INTEGER; numscan_opt->description = _("Number of scans to intergrate"); numscan_opt->required = NO; contours_map = G_define_standard_option(G_OPT_V_MAP); contours_map->key = "contours"; contours_map->required = NO; contours_map->description = _("Name of contour vector map"); contours_step_opt = G_define_option(); contours_step_opt->key = "contours_step"; contours_step_opt->description = _("Increment between contour levels"); contours_step_opt->type = TYPE_DOUBLE; contours_step_opt->required = NO; equalize_flag = G_define_flag(); equalize_flag->key = 'e'; equalize_flag->description = _("Histogram equalized color table"); loop_flag = G_define_flag(); loop_flag->key = 'l'; loop_flag->description = _("Keep scanning in a loop"); calib_flag = G_define_flag(); calib_flag->key = 'c'; calib_flag->description = _("Calibrate"); calib_flag->guisection = _("Calibration"); draw_opt = G_define_option(); draw_opt->key = "draw"; draw_opt->description = _("Draw with laser pointer"); draw_opt->type = TYPE_STRING; draw_opt->required = NO; draw_opt->options = "point,line,area"; draw_opt->answer = "point"; draw_opt->guisection = _("Drawing"); draw_threshold_opt = G_define_option(); draw_threshold_opt->key = "draw_threshold"; draw_threshold_opt->description = _("Brightness threshold for detecting laser pointer"); draw_threshold_opt->type = TYPE_INTEGER; draw_threshold_opt->required = YES; draw_threshold_opt->answer = "760"; draw_threshold_opt->guisection = _("Drawing"); draw_vector_opt = G_define_standard_option(G_OPT_V_OUTPUT); draw_vector_opt->key = "draw_output"; draw_vector_opt->guisection = _("Drawing"); draw_vector_opt->required = NO; G_option_required(calib_flag, routput_opt, voutput_opt, ply_opt, draw_vector_opt, NULL); G_option_requires(routput_opt, resolution_opt, NULL); G_option_requires(color_output_opt, resolution_opt, NULL); G_option_requires(contours_map, contours_step_opt, routput_opt, NULL); G_option_requires(equalize_flag, routput_opt, NULL); if (G_parser(argc, argv)) exit(EXIT_FAILURE); // initailization of variables double resolution = 0.002; if (resolution_opt->answer) resolution = atof(resolution_opt->answer); double smooth_radius = 0.008; if (smooth_radius_opt->answer) smooth_radius = atof(smooth_radius_opt->answer); char* routput = NULL; if (routput_opt->answer) routput = routput_opt->answer; /* parse zrange */ double zrange_min, zrange_max; if (zrange_opt->answer != NULL) { zrange_min = atof(zrange_opt->answers[0])/100; zrange_max = atof(zrange_opt->answers[1])/100; } /* parse trim */ double clip_N, clip_S, clip_E, clip_W; if (trim_opt->answer != NULL) { clip_N = atof(trim_opt->answers[0])/100; clip_S = atof(trim_opt->answers[1])/100; clip_E = atof(trim_opt->answers[2])/100; clip_W = atof(trim_opt->answers[3])/100; } double trim_tolerance; if (trim_tolerance_opt->answer) trim_tolerance = atof(trim_tolerance_opt->answer); double angle = pcl::deg2rad(atof(rotate_Z_opt->answer) + 180); double zexag = atof(zexag_opt->answer); Eigen::Matrix4f transform_matrix; if (calib_matrix_opt->answer) { transform_matrix = read_matrix(calib_matrix_opt); } char *method = method_opt->answer; int numscan = atoi(numscan_opt->answer); char *color_output = color_output_opt->answer; char *voutput = voutput_opt->answer; char *ply = ply_opt->answer; char *contours_output = contours_map->answer; double contours_step; if (contours_output) contours_step = atof(contours_step_opt->answer); bool use_equalized = false; if (equalize_flag->answer) use_equalized = true; // drawing int vect_type; get_draw_type(draw_opt->answer, vect_type); int draw_threshold = atoi(draw_threshold_opt->answer); char* draw_output = NULL; if (draw_vector_opt->answer) draw_output = draw_vector_opt->answer; std::vector<double> draw_x; std::vector<double> draw_y; std::vector<double> draw_z; bool drawing = false; unsigned int last_detected_loop_count = 1e6; struct Map_info Map_draw; struct line_pnts *Points_draw; struct line_cats *Cats_draw; Points_draw = Vect_new_line_struct(); Cats_draw = Vect_new_cats_struct(); Points = Vect_new_line_struct(); Cats = Vect_new_cats_struct(); pcl::PointCloud<pcl::PointXYZRGB>::Ptr cloud(new pcl::PointCloud<pcl::PointXYZRGB>(512, 424)); pcl::PointCloud<pcl::PointXYZRGB>::Ptr cloud_filtered_pass (new pcl::PointCloud<pcl::PointXYZRGB>(512, 424)); struct bound_box bbox; struct Cell_head cellhd, window; double offset, scale; bool region3D = false; bool paused = false; update_input_region(raster_opt->answer, region_opt->answer, window, offset, region3D); K2G k2g(OPENGL); k2g.getCloud(); cloud->sensor_orientation_.w() = 0.0; cloud->sensor_orientation_.x() = 1.0; cloud->sensor_orientation_.y() = 0.0; cloud->sensor_orientation_.z() = 0.0; int j = 0; // get terminating signals signal(SIGTERM, terminate); signal(SIGINT, terminate); signal(SIGUSR1, signal_read_new_input); while (j < 1) { if (signaled == 1) { break; } if (signal_new_input == 1) { signal_new_input = 0; read_new_input(routput, zrange_min, zrange_max, clip_N, clip_S, clip_E, clip_W, trim_tolerance, angle, zexag, method, numscan, smooth_radius, resolution, use_equalized, window, offset, region3D, color_output, voutput, ply, contours_output, contours_step, vect_type, draw_threshold, draw_output, paused); } cloud = k2g.getCloud(); if (paused) { continue; } if (!drawing) { for (int s = 0; s < numscan - 1; s++) *(cloud) += *(k2g.getCloud()); } // remove invalid points std::vector<int> index_nans; pcl::removeNaNFromPointCloud(*cloud, *cloud, index_nans); // calibration if(calib_flag->answer) { calibrate(cloud); j++; continue; } // rotation of the point cloud based on calibration if (calib_matrix_opt->answer) { rotate_with_matrix(cloud, transform_matrix); } // trim Z if (zrange_opt->answer != NULL) { trim_Z(cloud, zrange_min, zrange_max); } // rotation Z rotate_Z(cloud, angle); // specify bounding box from center if (trim_opt->answer != NULL) { clipNSEW(cloud, clip_N, clip_S, clip_E, clip_W); } // drawing if (draw_output) { int maxbright = 0; int maxbright_idx = 0; for (int i=0; i < cloud->points.size(); i++) { Eigen::Vector3i rgbv = cloud->points[i].getRGBVector3i(); int sum = rgbv[0] + rgbv[1] + rgbv[2]; if (sum > maxbright) { maxbright = sum; maxbright_idx = i; } } if (maxbright >= draw_threshold) { drawing = true; draw_x.push_back(cloud->points[maxbright_idx].x); draw_y.push_back(cloud->points[maxbright_idx].y); draw_z.push_back(cloud->points[maxbright_idx].z); last_detected_loop_count = 0; continue; } else { last_detected_loop_count++; if (last_detected_loop_count <= 2) { continue; } } } pcl::StatisticalOutlierRemoval<pcl::PointXYZRGB> sor; sor.setInputCloud(cloud); sor.setMeanK(20); sor.setStddevMulThresh(0.5); sor.filter(*cloud_filtered_pass); cloud_filtered_pass.swap (cloud); if (trim_tolerance_opt->answer != NULL) { double autoclip_N, autoclip_S, autoclip_E, autoclip_W; autotrim(cloud, autoclip_N, autoclip_S, autoclip_E, autoclip_W, trim_tolerance); if (autoclip_E > 0 || autoclip_N > 0 || autoclip_S > 0 || autoclip_W > 0) trimNSEW(cloud, autoclip_N, autoclip_S, autoclip_E, autoclip_W); } if (drawing) { // get Z scaling getMinMax(*cloud, bbox); if ((vect_type == GV_AREA && draw_x.size() > 2) || (vect_type == GV_LINE && draw_x.size() > 1) || (vect_type == GV_POINT && draw_x.size() > 0)) { save_vector(draw_output, Map_draw, Points_draw, Cats_draw, bbox, window, draw_x, draw_y, draw_z, vect_type, offset, zexag); } else G_warning(_("Tolopogically incorrect vector feature")); drawing = false; draw_x.clear(); draw_y.clear(); draw_z.clear(); last_detected_loop_count = 1e6; } if (voutput|| routput || ply || color_output) { if (smooth_radius_opt->answer) smooth(cloud, smooth_radius); // get Z scaling getMinMax(*cloud, bbox); scale = ((window.north - window.south) / (bbox.N - bbox.S) + (window.east - window.west) / (bbox.E - bbox.W)) / 2; } // write to vector if (voutput|| (routput && strcmp(method, "interpolation") == 0)) { double z; if (voutput) { if (Vect_open_new(&Map, voutput, WITH_Z) < 0) G_fatal_error(_("Unable to create temporary vector map <%s>"), voutput); } else { if (Vect_open_tmp_new(&Map, routput, WITH_Z) < 0) G_fatal_error(_("Unable to create temporary vector map <%s>"), routput); } for (int i=0; i < cloud->points.size(); i++) { Vect_reset_line(Points); Vect_reset_cats(Cats); if (region3D) z = (cloud->points[i].z + zrange_max) * scale / zexag + offset; else z = (cloud->points[i].z - bbox.B) * scale / zexag + offset; Vect_append_point(Points, cloud->points[i].x, cloud->points[i].y, z); Vect_cat_set(Cats, 1, cat); Vect_write_line(&Map, GV_POINT, Points, Cats); } if (strcmp(method, "interpolation") == 0) { // interpolate Vect_rewind(&Map); interpolate(&Map, routput, 20, 2, 50, 40, -1, &bbox, resolution); } Vect_close(&Map); } if (routput || color_output) { if (routput) { if (strcmp(method, "interpolation") != 0) { binning(cloud, routput, &bbox, resolution, scale, zexag, region3D ? -zrange_max : bbox.B, offset, method); } Rast_get_cellhd(routput, "", &cellhd); } if (color_output) { binning_color(cloud, color_output, &bbox, resolution); Rast_get_cellhd(get_color_name(color_output, "r"), "", &cellhd); } // georeference horizontally window.rows = cellhd.rows; window.cols = cellhd.cols; G_adjust_Cell_head(&window, 1, 1); cellhd.north = window.north; cellhd.south = window.south; cellhd.east = window.east; cellhd.west = window.west; if (routput) Rast_put_cellhd(routput, &cellhd); if (color_output) { char* output_r = get_color_name(color_output, "r"); char* output_g = get_color_name(color_output, "g"); char* output_b = get_color_name(color_output, "b"); Rast_put_cellhd(output_r, &cellhd); Rast_put_cellhd(output_g, &cellhd); Rast_put_cellhd(output_b, &cellhd); } set_default_color(routput); if (contours_output) { contours(routput, contours_output, atof(contours_step_opt->answer)); } if (use_equalized) { equalized(routput); } } // write to PLY if (ply) { pcl::PLYWriter writer; for (int i=0; i < cloud->points.size(); i++) { if (region3D) cloud->points[i].z = (cloud->points[i].z + zrange_max) * scale / zexag + offset; else cloud->points[i].z = (cloud->points[i].z - bbox.B) * scale / zexag + offset; cloud->points[i].x = (cloud->points[i].x - bbox.W) * scale + window.west; cloud->points[i].y = (cloud->points[i].y - bbox.S) * scale + window.south; } writer.write<pcl::PointXYZRGB>(ply, *cloud, true, true); } if (!loop_flag->answer) j++; } k2g.shutDown(); return EXIT_SUCCESS; }