static void readMapFile(const char * const rmapFileName, xelval const maxval, gray * const lumamap) { int rmcols, rmrows; gray rmmaxv; int rmformat; FILE * rmapfP; rmapfP = pm_openr(rmapFileName); pgm_readpgminit(rmapfP, &rmcols, &rmrows, &rmmaxv, &rmformat); if (rmmaxv != maxval) pm_error("maxval in map file (%u) different from input (%u)", rmmaxv, maxval); if (rmrows != 1) pm_error("Map must have 1 row. Yours has %u", rmrows); if (rmcols != maxval + 1) pm_error("Map must have maxval + 1 (%u) columns. Yours has %u", maxval + 1, rmcols); pgm_readpgmrow(rmapfP, lumamap, maxval+1, rmmaxv, rmformat); pm_close(rmapfP); }
static void convertPgmRaster(FILE * const ifP, int const format, xelval const maxval, unsigned int const cols, unsigned int const rows, FILE * const ofP, unsigned int const bytesPerLine, unsigned char * const data) { gray * const pixels = pgm_allocrow(cols); unsigned int row; for (row = 0; row < rows; ++row) { unsigned char * p; unsigned int col; size_t bytesWritten; p = &data[0]; pgm_readpgmrow(ifP, pixels, cols, maxval, format); for (col = 0; col < cols; ++col) *p++ = (unsigned char) pixels[col]; bytesWritten = fwrite(data, 1, bytesPerLine, ofP); if (bytesWritten != bytesPerLine) pm_error("File write error on Row %u", row); } pgm_freerow(pixels); }
int main(int argc, const char * argv[]) { FILE * ifP; gray * grayrow; int rows; int cols; unsigned int depth; int format; unsigned int padright; unsigned int row; gray maxval; const char * inputFile; pm_proginit(&argc, argv); if (argc-1 < 1) inputFile = "-"; else { inputFile = argv[1]; if (argc-1 > 2) pm_error("Too many arguments. The only argument is the optional " "input file name"); } ifP = pm_openr(inputFile); pgm_readpgminit(ifP, &cols, &rows, &maxval, &format); grayrow = pgm_allocrow(cols); depth = pm_maxvaltobits(maxval); /* Compute padding to round cols up to the nearest multiple of 32. */ padright = ((cols + 31) / 32) * 32 - cols; putinit(cols, rows, depth); for (row = 0; row < rows; ++row) { unsigned int col; pgm_readpgmrow(ifP, grayrow, cols, maxval, format); for (col = 0; col < cols; ++col) putval(grayrow[col]); for (col = 0; col < padright; ++col) putval(0); } pm_close(ifP); putrest(); return 0; }
static void convertLinear(FILE * const ifP, unsigned int const cols, unsigned int const rows, gray const maxval, int const format, const char * const colorNameBlack, const char * const colorNameWhite, FILE * const ofP, gray * const grayrow, pixel * const pixelrow) { pixel colorBlack, colorWhite; pixval red0, grn0, blu0, red1, grn1, blu1; unsigned int row; ppm_writeppminit(ofP, cols, rows, maxval, 0); colorBlack = ppm_parsecolor(colorNameBlack, maxval); colorWhite = ppm_parsecolor(colorNameWhite, maxval); red0 = PPM_GETR(colorBlack); grn0 = PPM_GETG(colorBlack); blu0 = PPM_GETB(colorBlack); red1 = PPM_GETR(colorWhite); grn1 = PPM_GETG(colorWhite); blu1 = PPM_GETB(colorWhite); for (row = 0; row < rows; ++row) { unsigned int col; pgm_readpgmrow(ifP, grayrow, cols, maxval, format); for (col = 0; col < cols; ++col) { gray const input = grayrow[col]; PPM_ASSIGN( pixelrow[col], (red0 * (maxval - input) + red1 * input) / maxval, (grn0 * (maxval - input) + grn1 * input) / maxval, (blu0 * (maxval - input) + blu1 * input) / maxval); } ppm_writeppmrow(ofP, pixelrow, cols, maxval, 0); } }
static void convertWithMap(FILE * const ifP, unsigned int const cols, unsigned int const rows, gray const maxval, int const format, const char * const mapFileName, FILE * const ofP, gray * const grayrow, pixel * const pixelrow) { unsigned int row; FILE * mapFileP; int mapcols, maprows; pixval mapmaxval; pixel ** mappixels; unsigned int mapmaxcolor; mapFileP = pm_openr(mapFileName); mappixels = ppm_readppm(mapFileP, &mapcols, &maprows, &mapmaxval); pm_close(mapFileP); mapmaxcolor = maprows * mapcols - 1; ppm_writeppminit(ofP, cols, rows, mapmaxval, 0); for (row = 0; row < rows; ++row) { unsigned int col; pgm_readpgmrow(ifP, grayrow, cols, maxval, format); for (col = 0; col < cols; ++col) { unsigned int c; if (maxval == mapmaxcolor) c = grayrow[col]; else c = grayrow[col] * mapmaxcolor / maxval; pixelrow[col] = mappixels[c / mapcols][c % mapcols]; } ppm_writeppmrow(ofP, pixelrow, cols, mapmaxval, 0); } ppm_freearray(mappixels, maprows); }
int main(int argc, char *argv[]) { FILE *in = stdin; FILE *out = stdout; FILE *sig = NULL; char output_name[MAXPATHLEN] = "(stdout)"; char input_name[MAXPATHLEN] = "(stdin)"; char signature_name[MAXPATHLEN]; int c; int row, col; int n; double quality = 0.0; int filter = 0; int method = -1; int level = 0; char filter_name[MAXPATHLEN] = ""; int seed; int verbose = 0; gray **image; Image_tree dwts; gray maxval; int rows, cols, colors, format; progname = argv[0]; pgm_init(&argc, argv); #ifdef __EMX__ _fsetmode(in, "b"); _fsetmode(out, "b"); #endif while ((c = getopt(argc, argv, "e:f:F:h?l:o:q:s:v:")) != EOF) { switch (c) { case 'e': method = atoi(optarg); if (method < 0) { fprintf(stderr, "%s: wavelet filtering method %d out of range\n", progname, method); exit(1); } break; case 'f': filter = atoi(optarg); if (filter <= 0) { fprintf(stderr, "%s: filter number %d out of range\n", progname, filter); exit(1); } break; case 'F': strcpy(filter_name, optarg); break; case 'h': case '?': usage(); break; case 'l': level = atoi(optarg); if (level < 1) { fprintf(stderr, "%s: embedding level out of range\n", progname); exit(1); } break; case 'o': if ((out = fopen(optarg, "wb")) == NULL) { fprintf(stderr, "%s: unable to open output file %s\n", progname, optarg); exit(1); } strcpy(output_name, optarg); break; case 'q': quality = atoi(optarg); if (quality <= 0) { fprintf(stderr, "%s: quality factor %d out of range\n", progname, quality); exit(1); } break; case 's': if ((sig = fopen(optarg, "r")) == NULL) { fprintf(stderr, "%s: unable to open signature file %s\n", progname, optarg); exit(1); } strcpy(signature_name, optarg); break; case 'v': verbose = atoi(optarg); if (verbose < 0) { fprintf(stderr, "%s: verbosity level %d out of range\n", progname, verbose); exit(1); } break; } } argc -= optind; argv += optind; if (argc > 1) { usage(); exit(1); } if (argc == 1 && *argv[0] != '-') if ((in = fopen(argv[0], "rb")) == NULL) { fprintf(stderr, "%s: unable to open input file %s\n", progname, argv[0]); exit(1); } else strcpy(input_name, argv[0]); if (sig) { char line[32]; fgets(line, sizeof(line), sig); if (strspn(line, "KDSG") >= 4) { fscanf(sig, "%d\n", &n); if (quality == 0.0) fscanf(sig, "%lf\n", &quality); else fscanf(sig, "%*f\n"); if (method < 0) fscanf(sig, "%d\n", &method); else fscanf(sig, "%*d\n"); if (filter == 0) fscanf(sig, "%d\n", &filter); else fscanf(sig, "%*d\n"); if (!strcmp(filter_name, "")) fscanf(sig, "%[^\n\r]\n", filter_name); else fscanf(sig, "%*[^\n\r]\n"); if (level == 0) fscanf(sig, "%d\n", &level); else fscanf(sig, "%*d\n"); fscanf(sig, "%d\n", &seed); srandom(seed); n_signature = NBITSTOBYTES(nbit_signature); fread(signature, sizeof(char), n_signature, sig); fscanf(sig, "\n"); } else { fprintf(stderr, "%s: invalid signature file %s\n", progname, signature_name); exit(1); } fclose(sig); } else { fprintf(stderr, "%s: signature file not specified, use -s file option\n", progname); exit(1); } pgm_readpgminit(in, &cols, &rows, &maxval, &format); image = pgm_allocarray(cols, rows); for (row = 0; row < rows; row++) pgm_readpgmrow(in, image[row], cols, maxval, format); fclose(in); // check watermark dimensions and decomposition level // decomposition of image init_dwt(cols, rows, filter_name, filter, level, method); #ifdef POLLEN_STUFF { double alpha, beta; char *alpha_str = getenv("POLLEN_ALPHA"), *beta_str = getenv("POLLEN_BETA"); if (alpha_str && beta_str) { alpha = atof(alpha_str); beta = atof(beta_str); if (alpha < -M_PI || alpha >= M_PI) { fprintf(stderr, "%s: pollen - alpha %f out of range\n", progname, alpha); exit(1); } if (beta < -M_PI || beta >= M_PI) { fprintf(stderr, "%s: pollen - beta %f out of range\n", progname, beta); exit(1); } if (verbose > 7) fprintf(stderr, "%s: pollen - alpha %f, beta %f\n", progname, alpha, beta); dwt_pollen_filter(alpha, beta); } } #endif dwts = fdwt(image); // create 'image' from binary watermark // decomposition of watermark init_dwt(cols, rows, filter_name, filter, 1, method); // dwts = fdwt(watermark); // calculate mean value of image and set alpha // setup of contrast sensitivity matrix // segment detail images at each level // calculate DFT of each segment // compute salience for each segment // calculate gamma or each detail image // embed watermark // reconstruction of watermarked image idwt(dwts, image); pgm_writepgminit(out, cols, rows, maxval, 0); for (row = 0; row < rows; row++) pgm_writepgmrow(out, image[row], cols, maxval, 0); fclose(out); pgm_freearray(image, rows); exit(0); }
int main(int argc, char * argv[]) { struct cmdlineInfo cmdline; FILE * ifP; int cols, rows; int median; enum medianMethod medianMethod; pgm_init(&argc, argv); parseCommandLine(argc, argv, &cmdline); ifP = pm_openr(cmdline.inputFileName); ccolso2 = cmdline.width / 2; crowso2 = cmdline.height / 2; pgm_readpgminit(ifP, &cols, &rows, &maxval, &format); pgm_writepgminit(stdout, cols, rows, maxval, forceplain); /* Allocate space for number of rows in mask size. */ grays = pgm_allocarray(cols, cmdline.height); grayrow = pgm_allocrow(cols); /* Read in and write out initial rows that won't get changed. */ for (row = 0; row < cmdline.height - 1; ++row) { pgm_readpgmrow(ifP, grays[row], cols, maxval, format); /* Write out the unchanged row. */ if (row < crowso2) pgm_writepgmrow(stdout, grays[row], cols, maxval, forceplain); } median = (cmdline.height * cmdline.width) / 2; /* Choose which sort to run. */ if (cmdline.type == MEDIAN_UNSPECIFIED) { if ((maxval / ((cmdline.width * cmdline.height) - 1)) < cmdline.cutoff) medianMethod = HISTOGRAM_SORT_MEDIAN; else medianMethod = SELECT_MEDIAN; } else medianMethod = cmdline.type; switch (medianMethod) { case SELECT_MEDIAN: selectMedian(ifP, cmdline.width, cmdline.height, cols, rows, median); break; case HISTOGRAM_SORT_MEDIAN: histogramSortMedian(ifP, cmdline.width, cmdline.height, cols, rows, median); break; case MEDIAN_UNSPECIFIED: pm_error("INTERNAL ERROR: median unspecified"); } pm_close(ifP); pm_close(stdout); pgm_freearray(grays, cmdline.height); pgm_freerow(grayrow); return 0; }
static void histogramSortMedian(FILE * const ifP, unsigned int const ccols, unsigned int const crows, unsigned int const cols, unsigned int const rows, unsigned int const median) { unsigned int const histmax = maxval + 1; unsigned int * hist; unsigned int mdn, ltmdn; gray * leftCol; gray * rghtCol; gray ** rowptr; MALLOCARRAY(rowptr, crows); MALLOCARRAY(hist, histmax); if (rowptr == NULL || hist == NULL) pm_error("Unable to allocate memory"); leftCol = pgm_allocrow(crows); rghtCol = pgm_allocrow(crows); /* Apply median to main part of image. */ for ( ; row < rows; ++row) { unsigned int col; unsigned int temprow; unsigned int rownum; unsigned int irow; unsigned int i; /* initialize hist[] */ for (i = 0; i < histmax; ++i) hist[i] = 0; pgm_readpgmrow(ifP, grays[row % crows], cols, maxval, format); /* Rotate pointers to rows, so rows can be accessed in order. */ temprow = (row + 1) % crows; rownum = 0; for (irow = temprow; irow < crows; ++rownum, ++irow) rowptr[rownum] = grays[irow]; for (irow = 0; irow < temprow; ++rownum, ++irow) rowptr[rownum] = grays[irow]; for (col = 0; col < cols; ++col) { if (col < ccolso2 || col >= cols - ccolso2) grayrow[col] = rowptr[crowso2][col]; else if (col == ccolso2) { unsigned int crow; unsigned int const leftcol = col - ccolso2; i = 0; for (crow = 0; crow < crows; ++crow) { unsigned int ccol; gray * const temprptr = rowptr[crow] + leftcol; for (ccol = 0; ccol < ccols; ++ccol) { gray const g = *(temprptr + ccol); ++hist[g]; ++i; } } ltmdn = 0; for (mdn = 0; ltmdn <= median; ++mdn) ltmdn += hist[mdn]; --mdn; if (ltmdn > median) ltmdn -= hist[mdn]; grayrow[col] = mdn; } else { unsigned int crow; unsigned int const subcol = col - (ccolso2 + 1); unsigned int const addcol = col + ccolso2; for (crow = 0; crow < crows; ++crow) { leftCol[crow] = *(rowptr[crow] + subcol); rghtCol[crow] = *(rowptr[crow] + addcol); } for (crow = 0; crow < crows; ++crow) { { gray const g = leftCol[crow]; --hist[(unsigned int) g]; if ((unsigned int) g < mdn) --ltmdn; } { gray const g = rghtCol[crow]; ++hist[(unsigned int) g]; if ((unsigned int) g < mdn) ++ltmdn; } } if (ltmdn > median) do { --mdn; ltmdn -= hist[mdn]; } while (ltmdn > median); else { /* This one change from Pitas algorithm can reduce run ** time by up to 10%. */ while (ltmdn <= median) { ltmdn += hist[mdn]; ++mdn; } --mdn; if (ltmdn > median) ltmdn -= hist[mdn]; } grayrow[col] = mdn; } } pgm_writepgmrow(stdout, grayrow, cols, maxval, forceplain); } { /* Write out remaining unchanged rows. */ unsigned int irow; for (irow = crowso2 + 1; irow < crows; ++irow) pgm_writepgmrow(stdout, rowptr[irow], cols, maxval, forceplain); } pgm_freerow(leftCol); pgm_freerow(rghtCol); free(hist); free(rowptr); }
static void selectMedian(FILE * const ifP, unsigned int const ccols, unsigned int const crows, unsigned int const cols, unsigned int const rows, unsigned int const median) { unsigned int const numValues = crows * ccols; unsigned int col; gray * garray; /* Array of the currenty gray values */ int * parray; int * subcol; gray ** rowptr; garray = pgm_allocrow(numValues); MALLOCARRAY(rowptr, crows); MALLOCARRAY(parray, numValues); MALLOCARRAY(subcol, cols); if (rowptr == NULL || parray == NULL || subcol == NULL) pm_error("Unable to allocate memory"); for (col = 0; col < cols; ++col) subcol[col] = (col - (ccolso2 + 1)) % ccols; /* Apply median to main part of image. */ for ( ; row < rows; ++row) { int crow; int rownum, irow, temprow; unsigned int col; pgm_readpgmrow(ifP, grays[row % crows], cols, maxval, format); /* Rotate pointers to rows, so rows can be accessed in order. */ temprow = (row + 1) % crows; rownum = 0; for (irow = temprow; irow < crows; ++rownum, ++irow) rowptr[rownum] = grays[irow]; for (irow = 0; irow < temprow; ++rownum, ++irow) rowptr[rownum] = grays[irow]; for (col = 0; col < cols; ++col) { if (col < ccolso2 || col >= cols - ccolso2) { grayrow[col] = rowptr[crowso2][col]; } else if (col == ccolso2) { unsigned int const leftcol = col - ccolso2; unsigned int i; i = 0; for (crow = 0; crow < crows; ++crow) { gray * const temprptr = rowptr[crow] + leftcol; unsigned int ccol; for (ccol = 0; ccol < ccols; ++ccol) { garray[i] = *(temprptr + ccol); parray[i] = i; ++i; } } select489(garray, parray, numValues, median); grayrow[col] = garray[parray[median]]; } else { unsigned int const addcol = col + ccolso2; unsigned int crow; unsigned int tsum; for (crow = 0, tsum = 0; crow < crows; ++crow, tsum += ccols) garray[tsum + subcol[col]] = *(rowptr[crow] + addcol ); select489( garray, parray, numValues, median ); grayrow[col] = garray[parray[median]]; } } pgm_writepgmrow( stdout, grayrow, cols, maxval, forceplain ); } { unsigned int irow; /* Write out remaining unchanged rows. */ for (irow = crowso2 + 1; irow < crows; ++irow) pgm_writepgmrow(stdout, rowptr[irow], cols, maxval, forceplain); } free(subcol); free(parray); free(rowptr); pgm_freerow(garray); }
static void histogram_sort_median(FILE * const ifp, int const ccols, int const crows, int const cols, int const rows, int const median) { int const histmax = maxval + 1; int *hist; int mdn, ltmdn; gray *left_col, *right_col; hist = (int *) pm_allocrow( histmax, sizeof( int ) ); left_col = pgm_allocrow( crows ); right_col = pgm_allocrow( crows ); /* Apply median to main part of image. */ for ( ; row < rows; ++row ) { int col; int temprow; int rownum; int irow; int i; /* initialize hist[] */ for ( i = 0; i < histmax; ++i ) hist[i] = 0; temprow = row % crows; pgm_readpgmrow( ifp, grays[temprow], cols, maxval, format ); /* Rotate pointers to rows, so rows can be accessed in order. */ temprow = ( row + 1 ) % crows; rownum = 0; for ( irow = temprow; irow < crows; ++rownum, ++irow ) rowptr[rownum] = grays[irow]; for ( irow = 0; irow < temprow; ++rownum, ++irow ) rowptr[rownum] = grays[irow]; for ( col = 0; col < cols; ++col ) { if ( col < ccolso2 || col >= cols - ccolso2 ) grayrow[col] = rowptr[crowso2][col]; else if ( col == ccolso2 ) { int crow; int const leftcol = col - ccolso2; i = 0; for ( crow = 0; crow < crows; ++crow ) { int ccol; gray * const temprptr = rowptr[crow] + leftcol; for ( ccol = 0; ccol < ccols; ++ccol ) { gray const g = *( temprptr + ccol ); ++hist[g]; ++i; } } ltmdn = 0; for ( mdn = 0; ltmdn <= median; ++mdn ) ltmdn += hist[mdn]; mdn--; if ( ltmdn > median ) ltmdn -= hist[mdn]; grayrow[col] = mdn; } else { int crow; int const subcol = col - ( ccolso2 + 1 ); int const addcol = col + ccolso2; for ( crow = 0; crow < crows; ++crow ) { left_col[crow] = *( rowptr[crow] + subcol ); right_col[crow] = *( rowptr[crow] + addcol ); } for ( crow = 0; crow < crows; ++crow ) { { gray const g = left_col[crow]; hist[(int) g]--; if ( (int) g < mdn ) ltmdn--; } { gray const g = right_col[crow]; hist[(int) g]++; if ( (int) g < mdn ) ltmdn++; } } if ( ltmdn > median ) do { mdn--; ltmdn -= hist[mdn]; } while ( ltmdn > median ); else { /* This one change from Pitas algorithm can reduce run ** time by up to 10%. */ while ( ltmdn <= median ) { ltmdn += hist[mdn]; mdn++; } mdn--; if ( ltmdn > median ) ltmdn -= hist[mdn]; } grayrow[col] = mdn; } } pgm_writepgmrow( stdout, grayrow, cols, maxval, forceplain ); } { /* Write out remaining unchanged rows. */ int irow; for ( irow = crowso2 + 1; irow < crows; ++irow ) pgm_writepgmrow( stdout, rowptr[irow], cols, maxval, forceplain ); } pm_freerow( (char *) hist ); pgm_freerow( left_col ); pgm_freerow( right_col ); }
static void select_median(FILE * const ifp, int const ccols, int const crows, int const cols, int const rows, int const median) { int ccol, col; int crow; int rownum, irow, temprow; gray *temprptr; int i, leftcol; int num_values; gray *garray; int *parray; int addcol; int *subcol; int tsum; /* Allocate storage for array of the current gray values. */ garray = pgm_allocrow( crows * ccols ); num_values = crows * ccols; parray = (int *) pm_allocrow( crows * ccols, sizeof(int) ); subcol = (int *) pm_allocrow( cols, sizeof(int) ); for ( i = 0; i < cols; ++i ) subcol[i] = ( i - (ccolso2 + 1) ) % ccols; /* Apply median to main part of image. */ for ( ; row < rows; ++row ) { temprow = row % crows; pgm_readpgmrow( ifp, grays[temprow], cols, maxval, format ); /* Rotate pointers to rows, so rows can be accessed in order. */ temprow = ( row + 1 ) % crows; rownum = 0; for ( irow = temprow; irow < crows; ++rownum, ++irow ) rowptr[rownum] = grays[irow]; for ( irow = 0; irow < temprow; ++rownum, ++irow ) rowptr[rownum] = grays[irow]; for ( col = 0; col < cols; ++col ) { if ( col < ccolso2 || col >= cols - ccolso2 ) { grayrow[col] = rowptr[crowso2][col]; } else if ( col == ccolso2 ) { leftcol = col - ccolso2; i = 0; for ( crow = 0; crow < crows; ++crow ) { temprptr = rowptr[crow] + leftcol; for ( ccol = 0; ccol < ccols; ++ccol ) { garray[i] = *( temprptr + ccol ); parray[i] = i; ++i; } } select_489( garray, parray, num_values, median ); grayrow[col] = garray[parray[median]]; } else { addcol = col + ccolso2; for (crow = 0, tsum = 0; crow < crows; ++crow, tsum += ccols) garray[tsum + subcol[col]] = *(rowptr[crow] + addcol ); select_489( garray, parray, num_values, median ); grayrow[col] = garray[parray[median]]; } } pgm_writepgmrow( stdout, grayrow, cols, maxval, forceplain ); } /* Write out remaining unchanged rows. */ for ( irow = crowso2 + 1; irow < crows; ++irow ) pgm_writepgmrow( stdout, rowptr[irow], cols, maxval, forceplain ); pgm_freerow( garray ); pm_freerow( (char *) parray ); pm_freerow( (char *) subcol ); }
COSTTYPE * readPGM(const char *fname, int *width, int *height, bool raw) { pm_init("navfn_tests",0); FILE *pgmfile; pgmfile = fopen(fname,"r"); if (!pgmfile) { printf("readPGM() Can't find file %s\n", fname); return NULL; } printf("readPGM() Reading costmap file %s\n", fname); int ncols, nrows; gray maxval; int format; pgm_readpgminit(pgmfile, &ncols, &nrows, &maxval, &format); printf("readPGM() Size: %d x %d\n", ncols, nrows); // set up cost map COSTTYPE *cmap = (COSTTYPE *)malloc(ncols*nrows*sizeof(COSTTYPE)); if (!raw) for (int i=0; i<ncols*nrows; i++) cmap[i] = COST_NEUTRAL; gray * row(pgm_allocrow(ncols)); int otot = 0; int utot = 0; int ftot = 0; for (int ii = 0; ii < nrows; ii++) { pgm_readpgmrow(pgmfile, row, ncols, maxval, format); if (raw) // raw costmap from ROS { for (int jj(ncols - 1); jj >= 0; --jj) { int v = row[jj]; cmap[ii*ncols+jj] = v; if (v >= COST_OBS_ROS) otot++; if (v == 0) ftot++; } } else { ftot = ncols*nrows; for (int jj(ncols - 1); jj >= 0; --jj) { if (row[jj] < unknown_gray && ii < nrows-7 && ii > 7) { setcostobs(cmap,ii*ncols+jj,ncols); otot++; ftot--; } else if (row[jj] <= unknown_gray) { setcostunk(cmap,ii*ncols+jj,ncols); utot++; ftot--; } } } } printf("readPGM() Found %d obstacle cells, %d free cells, %d unknown cells\n", otot, ftot, utot); pgm_freerow(row); *width = ncols; *height = nrows; return cmap; }
int main(int argc, char *argv[]) { FILE *ifd; FILE *ofd; int rows, cols; xelval maxval; int format; const char * const usage = "[-resolution x y] [pnmfile [ddiffile]]"; int i, j; char *outfile; int argn; int hor_resolution = 75; int ver_resolution = 75; imageparams ip; unsigned char *data, *p; pnm_init(&argc, argv); for (argn = 1;argn < argc && argv[argn][0] == '-';argn++) { int arglen = strlen(argv[argn]); if (!strncmp (argv[argn],"-resolution", arglen)) { if (argn + 2 < argc) { hor_resolution = atoi(argv[argn+1]); ver_resolution = atoi(argv[argn+2]); argn += 2; continue; } else { pm_usage(usage); } } else { pm_usage(usage); } } if (hor_resolution <= 0 || ver_resolution <= 0) { fprintf(stderr,"Unreasonable resolution values: %d x %d\n", hor_resolution,ver_resolution); exit(1); } if (argn == argc - 2) { ifd = pm_openr(argv[argn]); outfile = argv[argn+1]; if (!(ofd = fopen(outfile,"wb"))) { perror(outfile); exit(1); } } else if (argn == argc - 1) { ifd = pm_openr(argv[argn]); ofd = stdout; } else { ifd = stdin; ofd = stdout; } pnm_readpnminit(ifd, &cols, &rows, &maxval, &format); ip.width = cols; ip.height = rows; ip.h_res = hor_resolution; ip.v_res = ver_resolution; switch (PNM_FORMAT_TYPE(format)) { case PBM_TYPE: ip.bits_per_pixel = 1; ip.bytes_per_line = (cols + 7) / 8; ip.spectral = 2; ip.components = 1; ip.bits_per_component = 1; ip.polarity = 1; break; case PGM_TYPE: ip.bytes_per_line = cols; ip.bits_per_pixel = 8; ip.spectral = 2; ip.components = 1; ip.bits_per_component = 8; ip.polarity = 2; break; case PPM_TYPE: ip.bytes_per_line = 3 * cols; ip.bits_per_pixel = 24; ip.spectral = 5; ip.components = 3; ip.bits_per_component = 8; ip.polarity = 2; break; default: fprintf(stderr, "Unrecognized PBMPLUS format %d\n", format); exit(1); } if (!write_header(ofd,&ip)) { perror("Writing header"); exit(1); } if (!(p = data = (unsigned char*) malloc(ip.bytes_per_line))) { perror("allocating line buffer"); exit(1); } switch (PNM_FORMAT_TYPE(format)) { case PBM_TYPE: { bit *pixels; int mask; int k; pixels = pbm_allocrow(cols); for (i = 0; i < rows; i++) { pbm_readpbmrow(ifd, pixels, cols, format); mask = 0; p = data; for (j = 0, k = 0; j < cols; j++) { if (pixels[j] == PBM_BLACK) { mask |= 1 << k; } if (k == 7) { *p++ = mask; mask = 0; k = 0; } else { k++; } } if (k != 7) { /* Flush the rest of the column */ *p = mask; } if (fwrite(data,1,ip.bytes_per_line,ofd) != ip.bytes_per_line) { perror("Writing image data\n"); exit(1); } } } break; case PGM_TYPE: { gray *pixels = pgm_allocrow(cols); for (i = 0; i < rows; i++) { p = data; pgm_readpgmrow(ifd, pixels, cols, maxval, format); for (j = 0; j < cols; j++) { *p++ = (unsigned char) pixels[j]; } if (fwrite(data,1,ip.bytes_per_line,ofd) != ip.bytes_per_line) { perror("Writing image data\n"); exit(1); } } pgm_freerow(pixels); } break; case PPM_TYPE: { pixel *pixels = ppm_allocrow(cols); for (i = 0; i < rows; i++) { p = data; ppm_readppmrow(ifd, pixels, cols, maxval, format); for (j = 0; j < cols; j++) { *p++ = PPM_GETR(pixels[j]); *p++ = PPM_GETG(pixels[j]); *p++ = PPM_GETB(pixels[j]); } if (fwrite(data,1,ip.bytes_per_line,ofd) != ip.bytes_per_line) { perror("Writing image data\n"); exit(1); } } ppm_freerow(pixels); } break; } pm_close(ifd); free(data); if (!write_trailer(ofd)) { perror("Writing trailer"); exit(1); } if (fclose(ofd) == EOF) { perror("Closing output file"); exit(1); }; return(0); }
int main(int argc, char *argv[]) { FILE *in = stdin; FILE *out = stdout; FILE *orig = NULL; FILE *sig = NULL; gray **input_image; gray **orig_image; char signature_name[MAXPATHLEN]; char output_name[MAXPATHLEN] = "(stdout)"; char input_name[MAXPATHLEN] = "(stdin)"; char orig_name[MAXPATHLEN]; int c; int n = 0; int method = -1; int filter = 0; char filter_name[MAXPATHLEN] = ""; int level = 0; double alpha = 0.0; int in_rows, in_cols, in_format; gray in_maxval; int orig_rows, orig_cols, orig_format; gray orig_maxval; int rows, cols; int row, col; Image_tree input_dwts; Image_tree orig_dwts; int verbose = 0; progname = argv[0]; pgm_init(&argc, argv); wm_init2(); while ((c = getopt(argc, argv, "a:e:f:F:h?i:n:o:s:v:")) != EOF) { switch (c) { case 'a': alpha = atof(optarg); if (alpha <= 0.0) { fprintf(stderr, "%s: alpha factor %f out of range\n", progname, alpha); exit(1); } break; case 'e': method = atoi(optarg); if (method < 0) { fprintf(stderr, "%s: wavelet filtering method %d out of range\n", progname, method); exit(1); } break; case 'f': filter = atoi(optarg); if (filter <= 0) { fprintf(stderr, "%s: filter number %d out of range\n", progname, filter); exit(1); } break; case 'F': strcpy(filter_name, optarg); break; case 'h': case '?': usage(); break; case 'i': if ((orig = fopen(optarg, "rb")) == NULL) { fprintf(stderr, "%s: unable to open original image file %s\n", progname, optarg); exit(1); } strcpy(orig_name, optarg); break; case 'n': n = atoi(optarg); if (n < 1 || n > 1000) { fprintf(stderr, "%s: watermark length %d out of range\n", progname, n); exit(1); } break; case 'o': if ((out = fopen(optarg, "w")) == NULL) { fprintf(stderr, "%s: unable to open output file %s\n", progname, optarg); exit(1); } strcpy(output_name, optarg); break; case 's': if ((sig = fopen(optarg, "r")) == NULL) { fprintf(stderr, "%s: unable to open signature file %s\n", progname, optarg); exit(1); } strcpy(signature_name, optarg); break; case 'v': verbose = atoi(optarg); if (verbose < 0) { fprintf(stderr, "%s: verbosity level %d out of range\n", progname, verbose); exit(1); } break; } } argc -= optind; argv += optind; if (argc > 1) { usage(); exit(1); } if (argc == 1 && *argv[0] != '-') { if ((in = fopen(argv[0], "rb")) == NULL) { fprintf(stderr, "%s: unable to open input file %s\n", progname, argv[0]); exit(1); } else strcpy(input_name, argv[0]); } if (!orig) { fprintf(stderr, "%s: original image file not specified, use -i file option\n", progname); exit(1); } if (sig) { char line[32]; fgets(line, sizeof(line), sig); if (strspn(line, "CVSG") >= 4) { fscanf(sig, "%d\n", &n); if (alpha == 0.0) fscanf(sig, "%lf\n", &alpha); else fscanf(sig, "%*f\n"); if (method < 0) fscanf(sig, "%d\n", &method); else fscanf(sig, "%*d\n"); if (filter == 0) fscanf(sig, "%d\n", &filter); else fscanf(sig, "%*d\n"); if (!strcmp(filter_name, "")) fscanf(sig, "%[^\n\r]\n", filter_name); else fscanf(sig, "%*[^\n\r]\n"); } else { fprintf(stderr, "%s: invalid signature file %s\n", progname, signature_name); exit(1); } fclose(sig); } else { fprintf(stderr, "%s: signature file not specified, use -s file option\n", progname); exit(1); } pgm_readpgminit(in, &in_cols, &in_rows, &in_maxval, &in_format); pgm_readpgminit(orig, &orig_cols, &orig_rows, &orig_maxval, &orig_format); if (in_cols != orig_cols || in_rows != orig_rows) { fprintf(stderr, "%s: input image %s does not match dimensions of original image %s\n", progname, input_name, orig_name); exit(1); } cols = in_cols; rows = in_rows; input_image = pgm_allocarray(in_cols, in_rows); orig_image = pgm_allocarray(orig_cols, orig_rows); for (row = 0; row < in_rows; row++) pgm_readpgmrow(in, input_image[row], in_cols, in_maxval, in_format); fclose(in); for (row = 0; row < orig_rows; row++) pgm_readpgmrow(orig, orig_image[row], orig_cols, orig_maxval, orig_format); fclose(orig); level = 0; row = rows; col = cols; while (n < row * col / 4.0 && row >= 2 && col >= 2) { row /= 2; col /= 2; level++; } if (verbose >= 2) { fprintf(stderr, "%s: extracting from coarse image (x %d/y %d) at level %d\n", progname, col, row, level); } init_dwt(cols, rows, filter_name, filter, level, method); #ifdef POLLEN_STUFF #include "pollen_stuff.c" #endif #ifdef PARAM_STUFF #include "param_stuff.c" #endif input_dwts = fdwt(input_image); orig_dwts = fdwt(orig_image); fprintf(out, "CVWM\n"); fprintf(out, "%d\n", n); { Image_tree p = input_dwts; Image_tree q = orig_dwts; Image input_img; Image orig_img; double input_med; double orig_med; double input_var; double orig_var; while (!p->image) p = p->coarse; while (!q->image) q = q->coarse; input_img = p->image; orig_img = q->image; input_med = 0.0; for (row = 0; row < input_img->height; row++) for (col = 0; col < input_img->width; col++) input_med += get_pixel(input_img, col, row); input_med /= (double) (input_img->height * input_img->width); orig_med = 0.0; for (row = 0; row < orig_img->height; row++) for (col = 0; col < orig_img->width; col++) orig_med += get_pixel(orig_img, col, row); orig_med /= (double) (orig_img->height * orig_img->width); orig_var = 0.0; for (row = 0; row < orig_img->height; row++) for (col = 0; col < orig_img->width; col++) orig_var += sqr(get_pixel(orig_img, col, row) - orig_med); orig_var /= (double) (orig_img->height * orig_img->width); input_var = 0.0; for (row = 0; row < input_img->height; row++) for (col = 0; col < input_img->width; col++) input_var += sqr(get_pixel(input_img, col, row) - input_med); input_var /= (double) (input_img->height * input_img->width); orig_var = sqrt(orig_var); input_var = sqrt(input_var); if (verbose > 3) fprintf(stderr, "%s: mean (input, orig): %f, %f,\n variance (input, orig): %f, %f\n", progname, input_med, orig_med, input_var, orig_var); row = 0; col = 0; while (n > 0) { double input_pix; double orig_pix; double x; input_pix = get_pixel(input_img, col, row); orig_pix = get_pixel(orig_img, col, row); x = (((input_pix - input_med) * (orig_var / input_var) - (orig_pix / orig_med)) / (orig_pix - orig_med) - 1.0) / alpha; fprintf(out, "%f\n", x); if (++col == orig_img->width) { col = 0; row++; } n--; } } fclose(out); pgm_freearray(input_image, rows); pgm_freearray(orig_image, rows); exit(0); }
int main(int argc, char *argv[]) { FILE *in = stdin; FILE *out = stdout; FILE *sig = NULL; char output_name[MAXPATHLEN] = "(stdout)"; char input_name[MAXPATHLEN] = "(stdin)"; char signature_name[MAXPATHLEN]; int i, c, w; int row; int n; double alpha = 0.0; double beta = 0.0; int filter = 0; int method = -1; int level = 0; char filter_name[MAXPATHLEN] = ""; int verbose = 0; gray **image; Image_tree dwts; gray maxval; int rows, cols, format; double *watermark; progname = argv[0]; pgm_init(&argc, argv); wm_init(); while ((c = getopt(argc, argv, "a:b:e:f:F:h?o:s:v:")) != EOF) { switch (c) { case 'a': alpha = atof(optarg); if (alpha <= 0.0) { fprintf(stderr, "%s: alpha factor %f out of range\n", progname, alpha); exit(1); } break; case 'b': beta = atof(optarg); if (beta <= 0.0) { fprintf(stderr, "%s: beta factor %f out of range\n", progname, beta); exit(1); } break; case 'e': method = atoi(optarg); if (method < 0) { fprintf(stderr, "%s: wavelet filtering method %d out of range\n", progname, method); exit(1); } break; case 'f': filter = atoi(optarg); if (filter <= 0) { fprintf(stderr, "%s: filter number %d out of range\n", progname, filter); exit(1); } break; case 'F': strcpy(filter_name, optarg); break; case 'h': case '?': usage(); break; case 'o': if ((out = fopen(optarg, "wb")) == NULL) { fprintf(stderr, "%s: unable to open output file %s\n", progname, optarg); exit(1); } strcpy(output_name, optarg); break; case 's': if ((sig = fopen(optarg, "r")) == NULL) { fprintf(stderr, "%s: unable to open signature file %s\n", progname, optarg); exit(1); } strcpy(signature_name, optarg); break; case 'v': verbose = atoi(optarg); if (verbose < 0) { fprintf(stderr, "%s: verbosity level %d out of range\n", progname, verbose); exit(1); } break; } } argc -= optind; argv += optind; if (argc > 1) { usage(); exit(1); } if (argc == 1 && *argv[0] != '-') { if ((in = fopen(argv[0], "rb")) == NULL) { fprintf(stderr, "%s: unable to open input file %s\n", progname, argv[0]); exit(1); } else strcpy(input_name, argv[0]); } if (sig) { char line[32]; fgets(line, sizeof(line), sig); if (strspn(line, "WGSG") >= 4) { fscanf(sig, "%d\n", &n); if (alpha == 0.0) fscanf(sig, "%lf\n", &alpha); else fscanf(sig, "%*f\n"); if (beta == 0.0) fscanf(sig, "%lf\n", &beta); else fscanf(sig, "%*f\n"); if (method < 0) fscanf(sig, "%d\n", &method); else fscanf(sig, "%*d\n"); if (filter == 0) fscanf(sig, "%d\n", &filter); else fscanf(sig, "%*d\n"); if (!strcmp(filter_name, "")) fscanf(sig, "%[^\n\r]\n", filter_name); else fscanf(sig, "%*[^\n\r]\n"); } else { fprintf(stderr, "%s: invalid signature file %s\n", progname, signature_name); exit(1); } } else { fprintf(stderr, "%s: signature file not specified, use -s file option\n", progname); exit(1); } watermark = malloc(n * sizeof(double)); for (i = 0; i < n; i++) fscanf(sig, "%lf\n", &watermark[i]); fclose(sig); pgm_readpgminit(in, &cols, &rows, &maxval, &format); image = pgm_allocarray(cols, rows); for (row = 0; row < rows; row++) pgm_readpgmrow(in, image[row], cols, maxval, format); fclose(in); // complete decomposition level = find_deepest_level(cols, rows) - 1; // wavelet transform init_dwt(cols, rows, filter_name, filter, level, method); #ifdef POLLEN_STUFF #include "pollen_stuff.c" #endif #ifdef PARAM_STUFF #include "param_stuff.c" #endif dwts = fdwt(image); // build tree for subband selection, calculate subband thresholds init_subbands(dwts); set_subbands_type_beta(HORIZONTAL, beta); set_subbands_type_beta(VERTICAL, beta); calc_subbands_threshold(); w = 0; while (w < n) { Subband_data s; // select subband with max. threshold s = select_subband(); if (verbose > 1) fprintf(stderr, "%s: selected subband %s%d, T=%lf, beta=%lf\n", progname, subband_name(s->type), s->level, s->T, s->beta); // watermark significant coefficients and set them selected // check is entire signature has been embedded c = select_subband_coeff(s); do { double p; if (c < 0) // no more significant coefficients in subband break; p = get_subband_coeff(s, c); if (p < s->Cmax) { if (verbose > 2) fprintf(stderr, "%s: embedding sig. coeff. #%d (= %lf)\n into %s%d coeff. #%d\n", progname, w, watermark[w], subband_name(s->type), s->level, c); p = p + alpha * s->beta * s->T * watermark[w]; set_subband_coeff(s, c, p); w++; } mark_subband_coeff(s, c); // select next significant coefficient c = select_subband_coeff_from(s, c); } while (w < n); // update subband threshold s->T /= 2.0; } free_subbands(); free(watermark); idwt(dwts, image); pgm_writepgminit(out, cols, rows, maxval, 0); for (row = 0; row < rows; row++) pgm_writepgmrow(out, image[row], cols, maxval, 0); fclose(out); pgm_freearray(image, rows); exit(0); }
static void pgmHist(FILE * const ifP, int const cols, int const rows, xelval const maxval, int const format, bool const dots, bool const no_white, bool const no_black, bool const verbose, xelval const startval, xelval const endval, unsigned int const histWidth, unsigned int const histHeight, bool const clipSpec, unsigned int const clipCount) { gray * grayrow; bit ** bits; int i, j; unsigned int * ghist; double vscale; unsigned int hmax; MALLOCARRAY(ghist, histWidth); if (ghist == NULL) pm_error("Not enough memory for histogram array (%u bytes)", histWidth * (unsigned)sizeof(int)); bits = pbm_allocarray(histWidth, histHeight); if (bits == NULL) pm_error("no space for output array (%u bits)", histWidth * histHeight); memset(ghist, 0, histWidth * sizeof(ghist[0])); /* read the pixel values into the histogram arrays */ grayrow = pgm_allocrow(cols); if (verbose) pm_message("making histogram..."); for (i = rows; i > 0; --i) { pgm_readpgmrow (ifP, grayrow, cols, maxval, format); for (j = cols-1; j >= 0; --j) countComp(grayrow[j], startval, endval, histWidth, ghist); } pgm_freerow(grayrow); /* find the highest-valued slot and set the vertical scale value */ if (verbose) pm_message("finding max. slot height..."); if (clipSpec) hmax = clipCount; else hmax = maxSlotCount(ghist, histWidth, no_white, no_black); assert(hmax > 0); if (verbose) pm_message("Done: height = %u", hmax); clipHistogram(ghist, histWidth, hmax); vscale = (double) histHeight / hmax; for (i = 0; i < histWidth; ++i) { int mark = histHeight - (int)(vscale * ghist[i]); for (j = 0; j < mark; ++j) bits[j][i] = PBM_BLACK; if (j < histHeight) bits[j++][i] = PBM_WHITE; for ( ; j < histHeight; ++j) bits[j][i] = dots ? PBM_BLACK : PBM_WHITE; } pbm_writepbm(stdout, bits, histWidth, histHeight, 0); }
int main( int argc, char** argv ){ FILE *ifp; gray maxval; int cols, rows, format; gray* prevrow; gray* thisrow; gray* tmprow; int* countTile; int* countEdgeX; int* countEdgeY; int* countVertex; int i, col, row; int maxtiles, maxedgex, maxedgey, maxvertex; int area, perimeter, eulerchi; double l2inv, linv; /* * parse arg and initialize */ pgm_init( &argc, argv ); if ( argc > 2 ) pm_usage( "[pgmfile]" ); if ( argc == 2 ) ifp = pm_openr( argv[1] ); else ifp = stdin; /* * initialize */ pgm_readpgminit( ifp, &cols, &rows, &maxval, &format ); prevrow = pgm_allocrow( cols ); thisrow = pgm_allocrow( cols ); MALLOCARRAY(countTile , maxval + 1 ); MALLOCARRAY(countEdgeX , maxval + 1 ); MALLOCARRAY(countEdgeY , maxval + 1 ); MALLOCARRAY(countVertex , maxval + 1 ); if (countTile == NULL || countEdgeX == NULL || countEdgeY == NULL || countVertex == NULL) pm_error( "out of memory" ); for ( i = 0; i <= maxval; i++ ) countTile[i] = 0; for ( i = 0; i <= maxval; i++ ) countEdgeX[i] = 0; for ( i = 0; i <= maxval; i++ ) countEdgeY[i] = 0; for ( i = 0; i <= maxval; i++ ) countVertex[i] = 0; /* first row */ pgm_readpgmrow( ifp, thisrow, cols, maxval, format ); /* tiles */ for ( col = 0; col < cols; ++col ) ++countTile[thisrow[col]]; /* y-edges */ for ( col = 0; col < cols; ++col ) ++countEdgeY[thisrow[col]]; /* x-edges */ ++countEdgeX[thisrow[0]]; for ( col = 0; col < cols-1; ++col ) ++countEdgeX[ MAX2(thisrow[col], thisrow[col+1]) ]; ++countEdgeX[thisrow[cols-1]]; /* shortcut: for the first row, countVertex == countEdgeX */ ++countVertex[thisrow[0]]; for ( col = 0; col < cols-1; ++col ) ++countVertex[ MAX2(thisrow[col], thisrow[col+1]) ]; ++countVertex[thisrow[cols-1]]; for ( row = 1; row < rows; ++row ){ tmprow = prevrow; prevrow = thisrow; thisrow = tmprow; pgm_readpgmrow( ifp, thisrow, cols, maxval, format ); /* tiles */ for ( col = 0; col < cols; ++col ) ++countTile[thisrow[col]]; /* y-edges */ for ( col = 0; col < cols; ++col ) ++countEdgeY[ MAX2(thisrow[col], prevrow[col]) ]; /* x-edges */ ++countEdgeX[thisrow[0]]; for ( col = 0; col < cols-1; ++col ) ++countEdgeX[ MAX2(thisrow[col], thisrow[col+1]) ]; ++countEdgeX[thisrow[cols-1]]; /* vertices */ ++countVertex[ MAX2(thisrow[0],prevrow[0]) ]; for ( col = 0; col < cols-1; ++col ) ++countVertex[ MAX4(thisrow[col], thisrow[col+1], prevrow[col], prevrow[col+1]) ]; ++countVertex[ MAX2(thisrow[cols-1],prevrow[cols-1]) ]; } /* for row */ /* now thisrow contains the top row*/ /* tiles and x-edges have been counted, now upper y-edges and top vertices remain */ /* y-edges */ for ( col = 0; col < cols; ++col ) ++countEdgeY[ thisrow[col] ]; /* vertices */ ++countVertex[thisrow[0]]; for ( col = 0; col < cols-1; ++col ) ++countVertex[ MAX2(thisrow[col],thisrow[col+1]) ]; ++countVertex[ thisrow[cols-1] ]; /* cleanup */ maxtiles = rows * cols; maxedgex = rows * (cols+1); maxedgey = (rows+1) * cols; maxvertex= (rows+1) * (cols+1); l2inv = 1.0/maxtiles; linv = 0.5/(rows+cols); /* And print it. */ printf( "#threshold\t tiles\tx-edges\ty-edges\tvertices\n" ); printf( "#---------\t -----\t-------\t-------\t--------\n" ); for ( i = 0; i <= maxval; i++ ){ if( !(countTile[i] || countEdgeX[i] || countEdgeY[i] || countVertex[i] ) ) continue; /* skip empty slots */ area = maxtiles; perimeter = 2*maxedgex + 2*maxedgey - 4*maxtiles; eulerchi = maxtiles - maxedgex - maxedgey + maxvertex; printf( "%f\t%6d\t%7d\t%7d\t%8d\t%g\t%g\t%6d\n", (float) i/(1.0*maxval), maxtiles, maxedgex, maxedgey, maxvertex, area*l2inv, perimeter*linv, eulerchi ); maxtiles -= countTile[i]; maxedgex -= countEdgeX[i]; maxedgey -= countEdgeY[i]; maxvertex-= countVertex[i]; /* i, countTile[i], countEdgeX[i], countEdgeY[i], countVertex[i] */ } /* these should be zero: */ printf( "# check:\t%6d\t%7d\t%7d\t%8d\n", maxtiles, maxedgex, maxedgey, maxvertex ); pm_close( ifp ); exit( 0 ); } /*main*/