X-Git-Url: http://git.kpe.io/?p=ctsim.git;a=blobdiff_plain;f=libctsim%2Fimagefile.cpp;h=d4c973cc3a4a1aeeb1f7be4054c9f9ade7f581ff;hp=3e97fb25c3db7315c25625e8a54ae373ab6299dd;hb=fd1d136a94a6d20013f38d6a997bdfefad0f5e98;hpb=efc398029330f4d9170257db29e4420e50f25625 diff --git a/libctsim/imagefile.cpp b/libctsim/imagefile.cpp index 3e97fb2..d4c973c 100644 --- a/libctsim/imagefile.cpp +++ b/libctsim/imagefile.cpp @@ -9,7 +9,7 @@ ** This is part of the CTSim program ** Copyright (C) 1983-2000 Kevin Rosenberg ** -** $Id: imagefile.cpp,v 1.21 2000/12/17 19:08:06 kevin Exp $ +** $Id: imagefile.cpp,v 1.22 2000/12/20 20:08:48 kevin Exp $ ** ** This program is free software; you can redistribute it and/or modify ** it under the terms of the GNU General Public License (version 2) as @@ -29,53 +29,53 @@ F32Image::F32Image (int nx, int ny) - : Array2dFile (nx, ny, sizeof(kfloat32), Array2dFile::PIXEL_FLOAT32) - { - } +: Array2dFile (nx, ny, sizeof(kfloat32), Array2dFile::PIXEL_FLOAT32) +{ +} F32Image::F32Image (void) - : Array2dFile() - { - setPixelFormat (Array2dFile::PIXEL_FLOAT32); - setPixelSize (sizeof(kfloat32)); - } +: Array2dFile() +{ + setPixelFormat (Array2dFile::PIXEL_FLOAT32); + setPixelSize (sizeof(kfloat32)); +} F64Image::F64Image (int nx, int ny) - : Array2dFile (nx, ny, sizeof(kfloat64), Array2dFile::PIXEL_FLOAT64) - { - } +: Array2dFile (nx, ny, sizeof(kfloat64), Array2dFile::PIXEL_FLOAT64) +{ +} F64Image::F64Image (void) - : Array2dFile () - { - setPixelFormat (PIXEL_FLOAT64); - setPixelSize (sizeof(kfloat64)); - } +: Array2dFile () +{ + setPixelFormat (PIXEL_FLOAT64); + setPixelSize (sizeof(kfloat64)); +} void ImageFile::filterResponse (const char* const domainName, double bw, const char* const filterName, double filt_param) { - int hx = (m_nx - 1) / 2; - int hy = (m_ny - 1) / 2; - ImageFileArray v = getArray(); - SignalFilter filter (filterName, domainName, bw, filt_param); - - for (int i = -hx; i <= hx; i++) { - for (int j = -hy; j <= hy; j++) { - double r = sqrt (i * i + j * j); - - v[i+hx][j+hy] = filter.response (r); - } - } + int hx = (m_nx - 1) / 2; + int hy = (m_ny - 1) / 2; + ImageFileArray v = getArray(); + SignalFilter filter (filterName, domainName, bw, filt_param); + + for (int i = -hx; i <= hx; i++) { + for (int j = -hy; j <= hy; j++) { + double r = sqrt (i * i + j * j); + + v[i+hx][j+hy] = filter.response (r); + } + } } int ImageFile::display (void) const { double pmin, pmax; - + getMinMax (pmin, pmax); - + return (displayScaling (1, pmin, pmax)); } @@ -86,35 +86,35 @@ ImageFile::displayScaling (const int scale, const ImageFileValue pmin, const Ima int ny = m_ny; ImageFileArrayConst v = getArray(); if (v == NULL || nx == 0 || ny == 0) - return 0; - + return 0; + #if HAVE_G2_H int* pPens = new int [nx * ny * scale * scale ]; - + double view_scale = 255 / (pmax - pmin); int id_X11 = g2_open_X11 (nx * scale, ny * scale); int grayscale[256]; for (int i = 0; i < 256; i++) { - double cval = i / 255.; - grayscale[i] = g2_ink (id_X11, cval, cval, cval); + double cval = i / 255.; + grayscale[i] = g2_ink (id_X11, cval, cval, cval); } - + for (int iy = ny - 1; iy >= 0; iy--) { - int iRowPos = ((ny - 1 - iy) * scale) * (nx * scale); - for (int ix = 0; ix < nx; ix++) { - int cval = static_cast((v[ix][iy] - pmin) * view_scale); - if (cval < 0) - cval = 0; - else if (cval > 255) - cval = 255; - for (int sy = 0; sy < scale; sy++) - for (int sx = 0; sx < scale; sx++) - pPens[iRowPos+(sy * nx * scale)+(sx + (ix * scale))] = grayscale[cval]; - } + int iRowPos = ((ny - 1 - iy) * scale) * (nx * scale); + for (int ix = 0; ix < nx; ix++) { + int cval = static_cast((v[ix][iy] - pmin) * view_scale); + if (cval < 0) + cval = 0; + else if (cval > 255) + cval = 255; + for (int sy = 0; sy < scale; sy++) + for (int sx = 0; sx < scale; sx++) + pPens[iRowPos+(sy * nx * scale)+(sx + (ix * scale))] = grayscale[cval]; + } } - + g2_image (id_X11, 0., 0., nx * scale, ny * scale, pPens); - + delete pPens; return (id_X11); #else @@ -138,56 +138,56 @@ bool ImageFile::comparativeStatistics (const ImageFile& imComp, double& d, double& r, double& e) const { if (imComp.nx() != m_nx && imComp.ny() != m_ny) { - sys_error (ERR_WARNING, "Image sizes differ [ImageFile::comparativeStatistics]"); - return false; + sys_error (ERR_WARNING, "Image sizes differ [ImageFile::comparativeStatistics]"); + return false; } ImageFileArrayConst v = getArray(); if (v == NULL || m_nx == 0 || m_ny == 0) - return false; - + return false; + ImageFileArrayConst vComp = imComp.getArray(); - + double myMean = 0.; for (unsigned int ix = 0; ix < m_nx; ix++) { - for (unsigned int iy = 0; iy < m_ny; iy++) { - myMean += v[ix][iy]; - } + for (unsigned int iy = 0; iy < m_ny; iy++) { + myMean += v[ix][iy]; + } } myMean /= (m_nx * m_ny); - + double sqErrorSum = 0.; double absErrorSum = 0.; double sqDiffFromMeanSum = 0.; double absValueSum = 0.; for (unsigned int ix2 = 0; ix2 < m_nx; ix2++) { - for (unsigned int iy = 0; iy < m_ny; iy++) { - double diff = v[ix2][iy] - vComp[ix2][iy]; - sqErrorSum += diff * diff; - absErrorSum += fabs(diff); - double diffFromMean = v[ix2][iy] - myMean; - sqDiffFromMeanSum += diffFromMean * diffFromMean; - absValueSum += fabs(v[ix2][iy]); - } + for (unsigned int iy = 0; iy < m_ny; iy++) { + double diff = v[ix2][iy] - vComp[ix2][iy]; + sqErrorSum += diff * diff; + absErrorSum += fabs(diff); + double diffFromMean = v[ix2][iy] - myMean; + sqDiffFromMeanSum += diffFromMean * diffFromMean; + absValueSum += fabs(v[ix2][iy]); + } } - + d = sqrt (sqErrorSum / sqDiffFromMeanSum); r = absErrorSum / absValueSum; - + int hx = m_nx / 2; int hy = m_ny / 2; double eMax = -1; for (int ix3 = 0; ix3 < hx; ix3++) { - for (int iy = 0; iy < hy; iy++) { - double avgPixel = 0.25 * (v[2*ix3][2*iy] + v[2*ix3+1][2*iy] + v[2*ix3][2*iy+1] + v[2*ix3+1][2*iy+1]); - double avgPixelComp = 0.25 * (vComp[2*ix3][2*iy] + vComp[2*ix3+1][2*iy] + vComp[2*ix3][2*iy+1] + vComp[2*ix3+1][2*iy+1]); - double error = fabs (avgPixel - avgPixelComp); - if (error > eMax) - eMax = error; - } + for (int iy = 0; iy < hy; iy++) { + double avgPixel = 0.25 * (v[2*ix3][2*iy] + v[2*ix3+1][2*iy] + v[2*ix3][2*iy+1] + v[2*ix3+1][2*iy+1]); + double avgPixelComp = 0.25 * (vComp[2*ix3][2*iy] + vComp[2*ix3+1][2*iy] + vComp[2*ix3][2*iy+1] + vComp[2*ix3+1][2*iy+1]); + double error = fabs (avgPixel - avgPixelComp); + if (error > eMax) + eMax = error; + } } - + e = eMax; - + return true; } @@ -195,15 +195,15 @@ ImageFile::comparativeStatistics (const ImageFile& imComp, double& d, double& r, bool ImageFile::printComparativeStatistics (const ImageFile& imComp, std::ostream& os) const { - double d, r, e; - - if (comparativeStatistics (imComp, d, r, e)) { - os << " Normalized root mean squared distance (d): " << d << std::endl; - os << " Normalized mean absolute distance (r): " << r << std::endl; - os << "Worst case distance (2x2 pixel average) (e): " << e << std::endl; - return true; - } - return false; + double d, r, e; + + if (comparativeStatistics (imComp, d, r, e)) { + os << " Normalized root mean squared distance (d): " << d << std::endl; + os << " Normalized mean absolute distance (r): " << r << std::endl; + os << "Worst case distance (2x2 pixel average) (e): " << e << std::endl; + return true; + } + return false; } @@ -211,9 +211,9 @@ void ImageFile::printStatistics (std::ostream& os) const { double min, max, mean, mode, median, stddev; - + statistics (min, max, mean, mode, median, stddev); - + os << " min: " << min << std::endl; os << " max: " << max << std::endl; os << " mean: " << mean << std::endl; @@ -231,59 +231,15 @@ ImageFile::statistics (double& min, double& max, double& mean, double& mode, dou ImageFileArrayConst v = getArray(); if (v == NULL || nx == 0 || ny == 0) - return; - - mean = 0; - min = v[0][0]; - max = v[0][0]; - for (int ix = 0; ix < nx; ix++) { - for (int iy = 0; iy < ny; iy++) { - if (v[ix][iy] > max) - max = v[ix][iy]; - if (v[ix][iy] < min) - min = v[ix][iy]; - mean += v[ix][iy]; - } - } - mean /= (nx * ny); - - static const int nbin = 1024; - int hist[ nbin ] = {0}; - double spread = max - min; - mode = 0; - stddev = 0; - for (int ix4 = 0; ix4 < nx; ix4++) { - for (int iy = 0; iy < ny; iy++) { - int b = static_cast((((v[ix4][iy] - min) / spread) * (nbin - 1)) + 0.5); - hist[b]++; - double diff = (v[ix4][iy] - mean); - stddev += diff * diff; - } - } - stddev = sqrt(stddev / (nx * ny)); - - int max_binindex = 0; - int max_bin = -1; - for (int ibin = 0; ibin < nbin; ibin++) { - if (hist[ibin] > max_bin) { - max_bin = hist[ibin]; - max_binindex = ibin; - } - } - - mode = (max_binindex * spread / (nbin - 1)) + min; - - int nPixels = nx * ny; - std::vector vecImage; - for (int ix5 = 0; ix5 < nx; ix5++) - for (int iy = 0; iy < ny; iy++) - vecImage.push_back (v[ix5][iy]); - std::sort(vecImage.begin(), vecImage.end()); + return; - if (nPixels % 2) // Odd - median = vecImage[((nPixels - 1) / 2)]; - else // Even - median = (vecImage[(nPixels / 2) - 1] + vecImage[nPixels / 2]) / 2; + std::vector vecImage (nx * ny); + for (int ix = 0; ix < nx; ix++) { + for (int iy = 0; iy < ny; iy++) + vecImage.push_back (v[ix][iy]); + } + + vectorNumericStatistics (vecImage, min, max, mean, mode, median, stddev); } @@ -295,91 +251,91 @@ ImageFile::getMinMax (double& min, double& max) const ImageFileArrayConst v = getArray(); if (v == NULL || nx == 0 || ny == 0) - return; - + return; + min = v[0][0]; max = v[0][0]; for (int ix = 0; ix < nx; ix++) { - for (int iy = 0; iy < ny; iy++) { - if (v[ix][iy] > max) - max = v[ix][iy]; - if (v[ix][iy] < min) - min = v[ix][iy]; - } + for (int iy = 0; iy < ny; iy++) { + if (v[ix][iy] > max) + max = v[ix][iy]; + if (v[ix][iy] < min) + min = v[ix][iy]; + } } } void ImageFile::writeImagePGM (const char *outfile, int nxcell, int nycell, double densmin, double densmax) { - FILE *fp; - int nx = m_nx; - int ny = m_ny; - ImageFileArray v = getArray(); - - unsigned char* rowp = new unsigned char [nx * nxcell]; - - if ((fp = fopen (outfile, "wb")) == NULL) - return; - - fprintf(fp, "P5\n"); - fprintf(fp, "%d %d\n", nx, ny); - fprintf(fp, "255\n"); - - for (int irow = ny - 1; irow >= 0; irow--) { - for (int icol = 0; icol < nx; icol++) { - int pos = icol * nxcell; - double dens = (v[icol][irow] - densmin) / (densmax - densmin); - dens = clamp (dens, 0., 1.); - for (int p = pos; p < pos + nxcell; p++) { - rowp[p] = static_cast (dens * 255.); - } - } - for (int ir = 0; ir < nycell; ir++) { - for (int ic = 0; ic < nx * nxcell; ic++) - fputc( rowp[ic], fp ); - } - } - - delete rowp; - fclose(fp); + FILE *fp; + int nx = m_nx; + int ny = m_ny; + ImageFileArray v = getArray(); + + unsigned char* rowp = new unsigned char [nx * nxcell]; + + if ((fp = fopen (outfile, "wb")) == NULL) + return; + + fprintf(fp, "P5\n"); + fprintf(fp, "%d %d\n", nx, ny); + fprintf(fp, "255\n"); + + for (int irow = ny - 1; irow >= 0; irow--) { + for (int icol = 0; icol < nx; icol++) { + int pos = icol * nxcell; + double dens = (v[icol][irow] - densmin) / (densmax - densmin); + dens = clamp (dens, 0., 1.); + for (int p = pos; p < pos + nxcell; p++) { + rowp[p] = static_cast (dens * 255.); + } + } + for (int ir = 0; ir < nycell; ir++) { + for (int ic = 0; ic < nx * nxcell; ic++) + fputc( rowp[ic], fp ); + } + } + + delete rowp; + fclose(fp); } void ImageFile::writeImagePGMASCII (const char *outfile, int nxcell, int nycell, double densmin, double densmax) { - FILE *fp; - int nx = m_nx; - int ny = m_ny; - ImageFileArray v = getArray(); - - unsigned char* rowp = new unsigned char [nx * nxcell]; - - if ((fp = fopen (outfile, "wb")) == NULL) - return; - - fprintf(fp, "P2\n"); - fprintf(fp, "%d %d\n", nx, ny); - fprintf(fp, "255\n"); - - for (int irow = ny - 1; irow >= 0; irow--) { - for (int icol = 0; icol < nx; icol++) { - int pos = icol * nxcell; - double dens = (v[icol][irow] - densmin) / (densmax - densmin); - dens = clamp (dens, 0., 1.); - for (int p = pos; p < pos + nxcell; p++) { - rowp[p] = static_cast (dens * 255.); - } - } - for (int ir = 0; ir < nycell; ir++) { - for (int ic = 0; ic < nx * nxcell; ic++) - fprintf(fp, "%d ", rowp[ic]); - fprintf(fp, "\n"); - } - } - - delete rowp; - fclose(fp); + FILE *fp; + int nx = m_nx; + int ny = m_ny; + ImageFileArray v = getArray(); + + unsigned char* rowp = new unsigned char [nx * nxcell]; + + if ((fp = fopen (outfile, "wb")) == NULL) + return; + + fprintf(fp, "P2\n"); + fprintf(fp, "%d %d\n", nx, ny); + fprintf(fp, "255\n"); + + for (int irow = ny - 1; irow >= 0; irow--) { + for (int icol = 0; icol < nx; icol++) { + int pos = icol * nxcell; + double dens = (v[icol][irow] - densmin) / (densmax - densmin); + dens = clamp (dens, 0., 1.); + for (int p = pos; p < pos + nxcell; p++) { + rowp[p] = static_cast (dens * 255.); + } + } + for (int ir = 0; ir < nycell; ir++) { + for (int ic = 0; ic < nx * nxcell; ic++) + fprintf(fp, "%d ", rowp[ic]); + fprintf(fp, "\n"); + } + } + + delete rowp; + fclose(fp); } @@ -387,69 +343,69 @@ ImageFile::writeImagePGMASCII (const char *outfile, int nxcell, int nycell, doub void ImageFile::writeImagePNG (const char *outfile, int bitdepth, int nxcell, int nycell, double densmin, double densmax) { - FILE *fp; - png_structp png_ptr; - png_infop info_ptr; - double max_out_level = (1 << bitdepth) - 1; - int nx = m_nx; - int ny = m_ny; - ImageFileArray v = getArray(); - - unsigned char* rowp = new unsigned char [nx * nxcell * (bitdepth / 8)]; - - if ((fp = fopen (outfile, "wb")) == NULL) - return; - - png_ptr = png_create_write_struct (PNG_LIBPNG_VER_STRING, NULL, NULL, NULL); - if (! png_ptr) - return; - - info_ptr = png_create_info_struct(png_ptr); - if (! info_ptr) { - png_destroy_write_struct(&png_ptr, (png_infopp) NULL); - fclose(fp); - return; - } - - if (setjmp(png_ptr->jmpbuf)) { - png_destroy_write_struct(&png_ptr, &info_ptr); - fclose(fp); - return; - } - - png_init_io(png_ptr, fp); - - png_set_IHDR(png_ptr, info_ptr, nx * nxcell, ny * nycell, bitdepth, PNG_COLOR_TYPE_GRAY, PNG_INTERLACE_NONE, PNG_COMPRESSION_TYPE_BASE, PNG_FILTER_TYPE_DEFAULT); - - png_write_info(png_ptr, info_ptr); - for (int irow = ny - 1; irow >= 0; irow--) { - png_bytep row_pointer = rowp; - - for (int icol = 0; icol < nx; icol++) { - int pos = icol * nxcell; - double dens = (v[icol][irow] - densmin) / (densmax - densmin); - dens = clamp (dens, 0., 1.); - unsigned int outval = static_cast (dens * max_out_level); - - for (int p = pos; p < pos + nxcell; p++) { - if (bitdepth == 8) - rowp[p] = outval; - else { - int rowpos = p * 2; - rowp[rowpos] = (outval >> 8) & 0xFF; - rowp[rowpos+1] = (outval & 0xFF); + FILE *fp; + png_structp png_ptr; + png_infop info_ptr; + double max_out_level = (1 << bitdepth) - 1; + int nx = m_nx; + int ny = m_ny; + ImageFileArray v = getArray(); + + unsigned char* rowp = new unsigned char [nx * nxcell * (bitdepth / 8)]; + + if ((fp = fopen (outfile, "wb")) == NULL) + return; + + png_ptr = png_create_write_struct (PNG_LIBPNG_VER_STRING, NULL, NULL, NULL); + if (! png_ptr) + return; + + info_ptr = png_create_info_struct(png_ptr); + if (! info_ptr) { + png_destroy_write_struct(&png_ptr, (png_infopp) NULL); + fclose(fp); + return; } - } - } - for (int ir = 0; ir < nycell; ir++) - png_write_rows (png_ptr, &row_pointer, 1); - } - - png_write_end(png_ptr, info_ptr); - png_destroy_write_struct(&png_ptr, &info_ptr); - delete rowp; - - fclose(fp); + + if (setjmp(png_ptr->jmpbuf)) { + png_destroy_write_struct(&png_ptr, &info_ptr); + fclose(fp); + return; + } + + png_init_io(png_ptr, fp); + + png_set_IHDR(png_ptr, info_ptr, nx * nxcell, ny * nycell, bitdepth, PNG_COLOR_TYPE_GRAY, PNG_INTERLACE_NONE, PNG_COMPRESSION_TYPE_BASE, PNG_FILTER_TYPE_DEFAULT); + + png_write_info(png_ptr, info_ptr); + for (int irow = ny - 1; irow >= 0; irow--) { + png_bytep row_pointer = rowp; + + for (int icol = 0; icol < nx; icol++) { + int pos = icol * nxcell; + double dens = (v[icol][irow] - densmin) / (densmax - densmin); + dens = clamp (dens, 0., 1.); + unsigned int outval = static_cast (dens * max_out_level); + + for (int p = pos; p < pos + nxcell; p++) { + if (bitdepth == 8) + rowp[p] = outval; + else { + int rowpos = p * 2; + rowp[rowpos] = (outval >> 8) & 0xFF; + rowp[rowpos+1] = (outval & 0xFF); + } + } + } + for (int ir = 0; ir < nycell; ir++) + png_write_rows (png_ptr, &row_pointer, 1); + } + + png_write_end(png_ptr, info_ptr); + png_destroy_write_struct(&png_ptr, &info_ptr); + delete rowp; + + fclose(fp); } #endif @@ -460,44 +416,44 @@ static const int N_GRAYSCALE=256; void ImageFile::writeImageGIF (const char *outfile, int nxcell, int nycell, double densmin, double densmax) { - gdImagePtr gif; - FILE *out; - int gs_indices[N_GRAYSCALE]; - int nx = m_nx; - int ny = m_ny; - ImageFileArray v = getArray(); - - unsigned char rowp [nx * nxcell]; - if (rowp == NULL) - return; - - gif = gdImageCreate(nx * nxcell, ny * nycell); - for (int i = 0; i < N_GRAYSCALE; i++) - gs_indices[i] = gdImageColorAllocate(gif, i, i, i); - - int lastrow = ny * nycell - 1; - for (int irow = 0; irow < ny; irow++) { - int rpos = irow * nycell; - for (int ir = rpos; ir < rpos + nycell; ir++) { - for (int icol = 0; icol < nx; icol++) { - int cpos = icol * nxcell; - double dens = (v[icol][irow] - densmin) / (densmax - densmin); - dens = clamp(dens, 0., 1.); - for (int ic = cpos; ic < cpos + nxcell; ic++) { - rowp[ic] = (unsigned int) (dens * (double) (N_GRAYSCALE - 1)); - gdImageSetPixel(gif, ic, lastrow - ir, gs_indices[rowp[ic]]); + gdImagePtr gif; + FILE *out; + int gs_indices[N_GRAYSCALE]; + int nx = m_nx; + int ny = m_ny; + ImageFileArray v = getArray(); + + unsigned char rowp [nx * nxcell]; + if (rowp == NULL) + return; + + gif = gdImageCreate(nx * nxcell, ny * nycell); + for (int i = 0; i < N_GRAYSCALE; i++) + gs_indices[i] = gdImageColorAllocate(gif, i, i, i); + + int lastrow = ny * nycell - 1; + for (int irow = 0; irow < ny; irow++) { + int rpos = irow * nycell; + for (int ir = rpos; ir < rpos + nycell; ir++) { + for (int icol = 0; icol < nx; icol++) { + int cpos = icol * nxcell; + double dens = (v[icol][irow] - densmin) / (densmax - densmin); + dens = clamp(dens, 0., 1.); + for (int ic = cpos; ic < cpos + nxcell; ic++) { + rowp[ic] = (unsigned int) (dens * (double) (N_GRAYSCALE - 1)); + gdImageSetPixel(gif, ic, lastrow - ir, gs_indices[rowp[ic]]); + } + } + } } - } - } - } - - if ((out = fopen(outfile,"w")) == NULL) { - sys_error(ERR_FATAL, "Error opening output file %s for writing", outfile); - return (1); - } - gdImageGif(gif,out); - fclose(out); - gdImageDestroy(gif); + + if ((out = fopen(outfile,"w")) == NULL) { + sys_error(ERR_FATAL, "Error opening output file %s for writing", outfile); + return (1); + } + gdImageGif(gif,out); + fclose(out); + gdImageDestroy(gif); } #endif