Update copyright date; remove old CVS keyword
[ctsim.git] / libctsim / imagefile.cpp
index df647ce930efad8de0b4a8288f14c99499fc71bb..51a8dea82e94f2924671f0a9998119b055963990 100644 (file)
@@ -1,15 +1,13 @@
 /*****************************************************************************
 ** FILE IDENTIFICATION
 **
-**     Name:         imagefile.cpp
-**      Purpose:      Imagefile classes
-**     Programmer:   Kevin Rosenberg
-**     Date Started: June 2000
+**      Name:           imagefile.cpp
+**  Purpose:      Imagefile classes
+**      Programmer:   Kevin Rosenberg
+**      Date Started: June 2000
 **
 **  This is part of the CTSim program
-**  Copyright (C) 1983-2000 Kevin Rosenberg
-**
-**  $Id: imagefile.cpp,v 1.28 2001/01/01 10:14:34 kevin Exp $
+**  Copyright (c) 1983-2009 Kevin Rosenberg
 **
 **  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
 ******************************************************************************/
 
 #include "ct.h"
+#ifdef HAVE_CTN_DICOM
+#include "ctndicom.h"
+#endif
+#include "interpolator.h"
 
+const double ImageFile::s_dRedGrayscaleFactor = 0.299;
+const double ImageFile::s_dGreenGrayscaleFactor = 0.587;
+const double ImageFile::s_dBlueGrayscaleFactor = 0.114;
 
-F32Image::F32Image (int nx, int ny, int dataType)\r
-: Array2dFile (nx, ny, sizeof(kfloat32), Array2dFile::PIXEL_FLOAT32, dataType)\r
-{\r
-}\r
-\r
-F32Image::F32Image (void)\r
-: Array2dFile()\r
-{\r
-  setPixelFormat (Array2dFile::PIXEL_FLOAT32);\r
-  setPixelSize (sizeof(kfloat32));\r
-  setDataType (Array2dFile::DATA_TYPE_REAL);\r
-}\r
-\r
-F64Image::F64Image (int nx, int ny, int dataType)\r
-: Array2dFile (nx, ny, sizeof(kfloat64), Array2dFile::PIXEL_FLOAT64, dataType)\r
-{\r
-}\r
-\r
-F64Image::F64Image (void)\r
-: Array2dFile ()\r
-{\r
-  setPixelFormat (PIXEL_FLOAT64);\r
-  setPixelSize (sizeof(kfloat64));\r
-  setDataType (Array2dFile::DATA_TYPE_REAL);\r
-}\r
-
-void 
-ImageFile::filterResponse (const char* const domainName, double bw, const char* const filterName, double filt_param)
-{\r
-  ImageFileArray v = getArray();\r
-  SignalFilter filter (filterName, domainName, bw, filt_param);\r
-\r
-#if 1\r
-  int iXCenter, iYCenter;\r
-  if (isEven (m_nx))\r
-    iXCenter = m_nx / 2;\r
-  else\r
-    iXCenter = (m_nx - 1) / 2;\r
-  if (isEven (m_ny))\r
-    iYCenter = m_ny / 2;\r
-  else\r
-    iYCenter = (m_ny - 1) / 2;\r
-\r
-  for (int ix = 0; ix < m_nx; ix++)\r
-    for (int iy = 0; iy < m_ny; iy++) {\r
-      long lD2 = (ix - iXCenter) * (ix - iXCenter) + (iy - iYCenter) * (iy - iYCenter);\r
-      double r = ::sqrt (static_cast<double>(lD2));\r
-      v[ix][iy] = filter.response (r);\r
-    }\r
-#else
-  int hx = (m_nx - 1) / 2;
-  int hy = (m_ny - 1) / 2;
-  
-  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);
-    }
-  }\r
+
+const int ImageFile::EXPORT_FORMAT_INVALID = -1;
+const int ImageFile::EXPORT_FORMAT_TEXT = 0;
+const int ImageFile::EXPORT_FORMAT_PGM = 1;
+const int ImageFile::EXPORT_FORMAT_PGMASCII = 2;
+#ifdef HAVE_PNG
+const int ImageFile::EXPORT_FORMAT_PNG = 3;
+const int ImageFile::EXPORT_FORMAT_PNG16 = 4;
+#endif
+#ifdef HAVE_CTN_DICOM
+const int ImageFile::EXPORT_FORMAT_DICOM = 5;
+#endif
+const int ImageFile::EXPORT_FORMAT_RAW = 6;
+
+const char* ImageFile::s_aszExportFormatName[] =
+{
+  "text",
+  "pgm",
+  "pgmascii",
+#ifdef HAVE_PNG
+  "png",
+  "png16",
+#endif
+#ifdef HAVE_CTN_DICOM
+  "dicom",
+#endif
+};
+
+const char* ImageFile::s_aszExportFormatTitle[] =
+{
+  "Text",
+  "PGM",
+  "PGM ASCII",
+#ifdef HAVE_PNG
+  "PNG",
+  "PNG 16-bit",
+#endif
+#ifdef HAVE_CTN_DICOM
+  "Dicom",
+#endif
+};
+const int ImageFile::s_iExportFormatCount = sizeof(s_aszExportFormatName) / sizeof(const char*);
+
+
+const int ImageFile::IMPORT_FORMAT_INVALID = -1;
+const int ImageFile::IMPORT_FORMAT_PPM = 0;
+#ifdef HAVE_PNG
+const int ImageFile::IMPORT_FORMAT_PNG = 1;
+#endif
+#ifdef HAVE_CTN_DICOM
+const int ImageFile::IMPORT_FORMAT_DICOM = 2;
+#endif
+
+
+const char* ImageFile::s_aszImportFormatName[] =
+{
+  "ppm",
+#ifdef HAVE_PNG
+  "png",
+#endif
+#ifdef HAVE_CTN_DICOM
+  "dicom",
+#endif
+};
+
+const char* ImageFile::s_aszImportFormatTitle[] =
+{
+  "PPM",
+#ifdef HAVE_PNG
+  "PNG",
+#endif
+#ifdef HAVE_CTN_DICOM
+  "Dicom",
 #endif
+};
+const int ImageFile::s_iImportFormatCount = sizeof(s_aszImportFormatName) / sizeof(const char*);
+
+
+
+F32Image::F32Image (int nx, int ny, int dataType)
+: Array2dFile (nx, ny, sizeof(kfloat32), Array2dFile::PIXEL_FLOAT32, dataType)
+{
 }
 
-int
-ImageFile::display (void) const
+F32Image::F32Image (void)
+: Array2dFile()
 {
-  double pmin, pmax;
-  
-  getMinMax (pmin, pmax);
-  
-  return (displayScaling (1, pmin, pmax));
+  setPixelFormat (Array2dFile::PIXEL_FLOAT32);
+  setPixelSize (sizeof(kfloat32));
+  setDataType (Array2dFile::DATA_TYPE_REAL);
 }
 
-int 
-ImageFile::displayScaling (const int scale, const ImageFileValue pmin, const ImageFileValue pmax) const
+F64Image::F64Image (int nx, int ny, int dataType)
+: Array2dFile (nx, ny, sizeof(kfloat64), Array2dFile::PIXEL_FLOAT64, dataType)
 {
-  int nx = m_nx;
-  int ny = m_ny;
-  ImageFileArrayConst v = getArray();
-  if (v == NULL || nx == 0 || ny == 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);
-  }
-  
-  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<int>((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
-  return 0;
-#endif
 }
 
+F64Image::F64Image (void)
+: Array2dFile ()
+{
+  setPixelFormat (PIXEL_FLOAT64);
+  setPixelSize (sizeof(kfloat64));
+  setDataType (Array2dFile::DATA_TYPE_REAL);
+}
+
+void
+ImageFile::getCenterCoordinates (unsigned int& iXCenter, unsigned int& iYCenter)
+{
+  if (isEven (m_nx))
+    iXCenter = m_nx / 2;
+  else
+    iXCenter = (m_nx - 1) / 2;
+
+  if (isEven (m_ny))
+    iYCenter = m_ny / 2;
+  else
+    iYCenter = (m_ny - 1) / 2;
+}
+
+
+void
+ImageFile::filterResponse (const char* const domainName, double bw, const char* const filterName,
+                           double filt_param, double dInputScale, double dOutputScale)
+{
+  ImageFileArray v = getArray();
+  SignalFilter filter (filterName, domainName, bw, filt_param);
+
+  unsigned int iXCenter, iYCenter;
+  getCenterCoordinates (iXCenter, iYCenter);
+
+  for (unsigned int ix = 0; ix < m_nx; ix++)
+    for (unsigned int iy = 0; iy < m_ny; iy++) {
+      long lD2 = ((ix - iXCenter) * (ix - iXCenter)) + ((iy - iYCenter) * (iy - iYCenter));
+      double r = ::sqrt (static_cast<double>(lD2)) * dInputScale;
+      v[ix][iy] = filter.response (r) * dOutputScale;
+    }
+}
 
 
 // ImageFile::comparativeStatistics    Calculate comparative stats
@@ -166,9 +192,9 @@ ImageFile::comparativeStatistics (const ImageFile& imComp, double& d, double& r,
   ImageFileArrayConst v = getArray();
   if (v == NULL || m_nx == 0 || m_ny == 0)
     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++) {
@@ -176,7 +202,7 @@ ImageFile::comparativeStatistics (const ImageFile& imComp, double& d, double& r,
     }
   }
   myMean /= (m_nx * m_ny);
-  
+
   double sqErrorSum = 0.;
   double absErrorSum = 0.;
   double sqDiffFromMeanSum = 0.;
@@ -191,10 +217,10 @@ ImageFile::comparativeStatistics (const ImageFile& imComp, double& d, double& r,
       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;
@@ -207,9 +233,9 @@ ImageFile::comparativeStatistics (const ImageFile& imComp, double& d, double& r,
         eMax = error;
     }
   }
-  
+
   e = eMax;
-  
+
   return true;
 }
 
@@ -218,7 +244,7 @@ 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;
@@ -233,69 +259,69 @@ void
 ImageFile::printStatistics (std::ostream& os) const
 {
   double min, max, mean, mode, median, stddev;
-  
-  statistics (min, max, mean, mode, median, stddev);\r
-  if (isComplex())\r
-    os << "Real Component Statistics" << std::endl;\r
-  
+
+  statistics (min, max, mean, mode, median, stddev);
+  if (isComplex())
+    os << "Real Component Statistics" << std::endl;
+
   os << "   min: " << min << std::endl;
   os << "   max: " << max << std::endl;
   os << "  mean: " << mean << std::endl;
   os << "  mode: " << mode << std::endl;
   os << "median: " << median << std::endl;
-  os << "stddev: " << stddev << std::endl;\r
-  \r
-  if (isComplex()) {\r
-    statistics (getImaginaryArray(), min, max, mean, mode, median, stddev);\r
+  os << "stddev: " << stddev << std::endl;
+
+  if (isComplex()) {
+    statistics (getImaginaryArray(), min, max, mean, mode, median, stddev);
     os << std::endl << "Imaginary Component Statistics" << std::endl;
-    os << "   min: " << min << std::endl;\r
-    os << "   max: " << max << std::endl;\r
-    os << "  mean: " << mean << std::endl;\r
-    os << "  mode: " << mode << std::endl;\r
-    os << "median: " << median << std::endl;\r
-    os << "stddev: " << stddev << std::endl;\r
-  }\r
+    os << "   min: " << min << std::endl;
+    os << "   max: " << max << std::endl;
+    os << "  mean: " << mean << std::endl;
+    os << "  mode: " << mode << std::endl;
+    os << "median: " << median << std::endl;
+    os << "stddev: " << stddev << std::endl;
+  }
 }
 
 
 void
 ImageFile::statistics (double& min, double& max, double& mean, double& mode, double& median, double& stddev) const
-{\r
-  ImageFileArrayConst v = getArray();\r
-  statistics (v, min, max, mean, mode, median, stddev);\r
+{
+  ImageFileArrayConst v = getArray();
+  statistics (v, min, max, mean, mode, median, stddev);
 }
 
 
-void\r
-ImageFile::statistics (ImageFileArrayConst v, double& min, double& max, double& mean, double& mode, double& median, double& stddev) const\r
-{\r
-  int nx = m_nx;\r
-  int ny = m_ny;\r
-  \r
-  if (v == NULL || nx == 0 || ny == 0)\r
-    return;\r
-  \r
-  std::vector<double> vecImage;\r
-  int iVec = 0;\r
-  vecImage.resize (nx * ny);\r
-  for (int ix = 0; ix < nx; ix++) {\r
-    for (int iy = 0; iy < ny; iy++)\r
-      vecImage[iVec++] = v[ix][iy];\r
-  }\r
-  \r
-  vectorNumericStatistics (vecImage, nx * ny, min, max, mean, mode, median, stddev);\r
-}\r
-\r
+void
+ImageFile::statistics (ImageFileArrayConst v, double& min, double& max, double& mean, double& mode, double& median, double& stddev) const
+{
+  int nx = m_nx;
+  int ny = m_ny;
+
+  if (v == NULL || nx == 0 || ny == 0)
+    return;
+
+  std::vector<double> vecImage;
+  int iVec = 0;
+  vecImage.resize (nx * ny);
+  for (int ix = 0; ix < nx; ix++) {
+    for (int iy = 0; iy < ny; iy++)
+      vecImage[iVec++] = v[ix][iy];
+  }
+
+  vectorNumericStatistics (vecImage, nx * ny, min, max, mean, mode, median, stddev);
+}
+
 void
 ImageFile::getMinMax (double& min, double& max) const
 {
   int nx = m_nx;
   int ny = m_ny;
   ImageFileArrayConst v = getArray();
-  
+
   if (v == NULL || nx == 0 || ny == 0)
     return;
-  
+
   min = v[0][0];
   max = v[0][0];
   for (int ix = 0; ix < nx; ix++) {
@@ -307,867 +333,1601 @@ ImageFile::getMinMax (double& min, double& max) const
     }
   }
 }
-\r
-bool\r
-ImageFile::convertRealToComplex ()\r
-{\r
-  if (dataType() != Array2dFile::DATA_TYPE_REAL)\r
-    return false;\r
-  \r
-  if (! reallocRealToComplex())\r
-    return false;\r
-  \r
-  ImageFileArray vImag = getImaginaryArray();\r
-  for (unsigned int ix = 0; ix < m_nx; ix++) {\r
-    ImageFileColumn vCol = vImag[ix];\r
-    for (unsigned int iy = 0; iy < m_ny; iy++)\r
-      *vCol++ = 0;\r
-  }\r
-  \r
-  return true;\r
-}\r
-\r
-bool\r
-ImageFile::convertComplexToReal ()\r
-{\r
-  if (dataType() != Array2dFile::DATA_TYPE_COMPLEX)\r
-    return false;\r
-  \r
-  ImageFileArray vReal = getArray();\r
-  ImageFileArray vImag = getImaginaryArray();\r
-  for (unsigned int ix = 0; ix < m_nx; ix++) {\r
-    ImageFileColumn vRealCol = vReal[ix];\r
-    ImageFileColumn vImagCol = vImag[ix];\r
-    for (unsigned int iy = 0; iy < m_ny; iy++) {\r
-      CTSimComplex c (*vRealCol, *vImagCol);\r
-      *vRealCol++ = std::abs (c);\r
-      vImagCol++;\r
-    }\r
-  }\r
-  \r
-  return reallocComplexToReal();\r
-}\r
-\r
-bool\r
-ImageFile::subtractImages (const ImageFile& rRHS, ImageFile& result) const\r
-{\r
-  if (m_nx != rRHS.nx() || m_ny != rRHS.ny() || m_nx != result.nx() || m_ny != result.ny()) {\r
-    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::subtractImage]");\r
-    return false;\r
-  }\r
-  \r
-  ImageFileArrayConst vLHS = getArray();\r
-  ImageFileArrayConst vRHS = rRHS.getArray();\r
-  ImageFileArray vResult = result.getArray();\r
-  \r
-  for (unsigned int ix = 0; ix < m_nx; ix++) {\r
-    ImageFileColumnConst in1 = vLHS[ix];\r
-    ImageFileColumnConst in2 = vRHS[ix];\r
-    ImageFileColumn out = vResult[ix];\r
-    for (unsigned int iy = 0; iy < m_ny; iy++)\r
-      *out++ = *in1++ - *in2++;\r
-  }\r
-  \r
-  return true;\r
-}\r
-
-bool\r
-ImageFile::addImages (const ImageFile& rRHS, ImageFile& result) const\r
-{\r
-  if (m_nx != rRHS.nx() || m_ny != rRHS.ny() || m_nx != result.nx() || m_ny != result.ny()) {\r
-    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::subtractImage]");\r
-    return false;\r
-  }\r
-  \r
-  ImageFileArrayConst vLHS = getArray();\r
-  ImageFileArrayConst vRHS = rRHS.getArray();\r
-  ImageFileArray vResult = result.getArray();\r
-  \r
-  for (unsigned int ix = 0; ix < m_nx; ix++) {\r
-    ImageFileColumnConst in1 = vLHS[ix];\r
-    ImageFileColumnConst in2 = vRHS[ix];\r
-    ImageFileColumn out = vResult[ix];\r
-    for (unsigned int iy = 0; iy < m_ny; iy++)\r
-      *out++ = *in1++ + *in2++;\r
-  }\r
-  \r
-  return true;\r
-}\r
-\r
-bool\r
-ImageFile::multiplyImages (const ImageFile& rRHS, ImageFile& result) const\r
-{\r
-  if (m_nx != rRHS.nx() || m_ny != rRHS.ny() || m_nx != result.nx() || m_ny != result.ny()) {\r
-    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::subtractImage]");\r
-    return false;\r
-  }\r
-  \r
-  ImageFileArrayConst vLHS = getArray();\r
-  ImageFileArrayConst vRHS = rRHS.getArray();\r
-  ImageFileArray vResult = result.getArray();\r
-  \r
-  for (unsigned int ix = 0; ix < m_nx; ix++) {\r
-    ImageFileColumnConst in1 = vLHS[ix];\r
-    ImageFileColumnConst in2 = vRHS[ix];\r
-    ImageFileColumn out = vResult[ix];\r
-    for (unsigned int iy = 0; iy < m_ny; iy++)\r
-      *out++ = *in1++ * *in2++;\r
-  }\r
-  \r
-  return true;\r
-}\r
-\r
-bool\r
-ImageFile::divideImages (const ImageFile& rRHS, ImageFile& result) const\r
-{\r
-  if (m_nx != rRHS.nx() || m_ny != rRHS.ny() || m_nx != result.nx() || m_ny != result.ny()) {\r
-    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::subtractImage]");\r
-    return false;\r
-  }\r
-  \r
-  ImageFileArrayConst vLHS = getArray();\r
-  ImageFileArrayConst vRHS = rRHS.getArray();\r
-  ImageFileArray vResult = result.getArray();\r
-  \r
-  for (unsigned int ix = 0; ix < m_nx; ix++) {\r
-    ImageFileColumnConst in1 = vLHS[ix];\r
-    ImageFileColumnConst in2 = vRHS[ix];\r
-    ImageFileColumn out = vResult[ix];\r
-    for (unsigned int iy = 0; iy < m_ny; iy++) {\r
-      if (*in2 != 0.)\r
-        *out++ = *in1++ / *in2++;\r
-      else\r
-        *out++ = 0;\r
-    }\r
-  }\r
-  \r
-  return true;\r
-}\r
-\r
-\r
-bool\r
-ImageFile::invertPixelValues (ImageFile& result) const\r
-{\r
-  if (m_nx != result.nx() || m_ny != result.ny()) {\r
-    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");\r
-    return false;\r
-  }\r
-  \r
-  ImageFileArrayConst vLHS = getArray();\r
-  ImageFileArray vResult = result.getArray();\r
-  \r
-  for (unsigned int ix = 0; ix < m_nx; ix++) {\r
-    ImageFileColumnConst in = vLHS[ix];\r
-    ImageFileColumn out = vResult[ix];\r
-    for (unsigned int iy = 0; iy < m_ny; iy++)\r
-      *out++ = - *in++;\r
-  }\r
-  \r
-  return true;\r
-}\r
-\r
-bool\r
-ImageFile::sqrt (ImageFile& result) const\r
-{\r
-  if (m_nx != result.nx() || m_ny != result.ny()) {\r
-    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");\r
-    return false;\r
-  }\r
-  \r
-  ImageFileArrayConst vLHS = getArray();\r
-  ImageFileArray vResult = result.getArray();\r
-  \r
-  for (unsigned int ix = 0; ix < m_nx; ix++) {\r
-    ImageFileColumnConst in = vLHS[ix];\r
-    ImageFileColumn out = vResult[ix];\r
-    for (unsigned int iy = 0; iy < m_ny; iy++)\r
-      if (*in < 0)\r
-        *out++ = -::sqrt(-*in++);\r
-      else\r
-        *out++ = ::sqrt(*in++);\r
-  }\r
-  \r
-  return true;\r
-}\r
-\r
-bool\r
-ImageFile::log (ImageFile& result) const\r
-{\r
-  if (m_nx != result.nx() || m_ny != result.ny()) {\r
-    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");\r
-    return false;\r
-  }\r
-  \r
-  ImageFileArrayConst vLHS = getArray();\r
-  ImageFileArray vResult = result.getArray();\r
-  \r
-  for (unsigned int ix = 0; ix < m_nx; ix++) {\r
-    ImageFileColumnConst in = vLHS[ix];\r
-    ImageFileColumn out = vResult[ix];\r
-    for (unsigned int iy = 0; iy < m_ny; iy++)\r
-      if (*in <= 0)\r
-        *out++ = 0;\r
-      else\r
-        *out++ = ::log(*in++);\r
-  }\r
-  \r
-  return true;\r
-}\r
-\r
-bool\r
-ImageFile::exp (ImageFile& result) const\r
-{\r
-  if (m_nx != result.nx() || m_ny != result.ny()) {\r
-    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");\r
-    return false;\r
-  }\r
-  \r
-  ImageFileArrayConst vLHS = getArray();\r
-  ImageFileArray vResult = result.getArray();\r
-  \r
-  for (unsigned int ix = 0; ix < m_nx; ix++) {\r
-    ImageFileColumnConst in = vLHS[ix];\r
-    ImageFileColumn out = vResult[ix];\r
-    for (unsigned int iy = 0; iy < m_ny; iy++)\r
-      *out++ = ::exp (*in++);\r
-  }\r
-  \r
-  return true;\r
-}\r
-\r
-namespace ProcessImage {\r
-\r
-void\r
-shuffleFourierToNaturalOrder (ImageFile& im)\r
-{\r
-  ImageFileArray vReal = im.getArray();\r
-  ImageFileArray vImag = im.getImaginaryArray();\r
-  unsigned int ix, iy;\r
-  unsigned int nx = im.nx();\r
-  unsigned int ny = im.ny();\r
-\r
-  // shuffle each column\r
-  for (ix = 0; ix < nx; ix++) {\r
-    ProcessSignal::shuffleFourierToNaturalOrder (vReal[ix], ny);\r
-    if (im.isComplex())\r
-      ProcessSignal::shuffleFourierToNaturalOrder (vImag[ix], ny);\r
-  }\r
-\r
-  // shuffle each row\r
-  float* pRow = new float [nx];\r
-  for (iy = 0; iy < ny; iy++) {\r
-    for (ix = 0; ix < nx; ix++)\r
-      pRow[ix] = vReal[ix][iy];\r
-    ProcessSignal::shuffleFourierToNaturalOrder (pRow, nx);\r
-    for (ix = 0; ix < nx; ix++)\r
-      vReal[ix][iy] = pRow[ix];\r
-    if (im.isComplex()) {\r
-      for (ix = 0; ix < nx; ix++)\r
-        pRow[ix] = vImag[ix][iy];\r
-      ProcessSignal::shuffleFourierToNaturalOrder (pRow, nx);;\r
-      for (ix = 0; ix < nx; ix++)\r
-        vImag[ix][iy] = pRow[ix];\r
-    }\r
-  }\r
-  delete pRow;\r
-}\r
\r
-void\r
-shuffleNaturalToFourierOrder (ImageFile& im)\r
-{\r
-  ImageFileArray vReal = im.getArray();\r
-  ImageFileArray vImag = im.getImaginaryArray();\r
-  unsigned int ix, iy;\r
-  unsigned int nx = im.nx();\r
-  unsigned int ny = im.ny();\r
-\r
-  // shuffle each x column\r
-  for (ix = 0; ix < nx; ix++) {\r
-    ProcessSignal::shuffleNaturalToFourierOrder (vReal[ix], ny);\r
-    if (im.isComplex())\r
-      ProcessSignal::shuffleNaturalToFourierOrder (vImag[ix], ny);\r
-  }\r
-\r
-  // shuffle each y row\r
-  float* pRow = new float [nx];\r
-  for (iy = 0; iy < ny; iy++) {\r
-    for (ix = 0; ix < nx; ix++)\r
-      pRow[ix] = vReal[ix][iy];\r
-    ProcessSignal::shuffleNaturalToFourierOrder (pRow, nx);\r
-    for (ix = 0; ix < nx; ix++)\r
-      vReal[ix][iy] = pRow[ix];\r
-    if (im.isComplex()) {\r
-      for (ix = 0; ix < nx; ix++)\r
-        pRow[ix] = vImag[ix][iy];\r
-      ProcessSignal::shuffleNaturalToFourierOrder (pRow, nx);\r
-      for (ix = 0; ix < nx; ix++)\r
-        vImag[ix][iy] = pRow[ix];\r
-    }\r
-  }\r
-  delete [] pRow;\r
-}\r
-\r
\r
-}; // namespace ProcessIamge\r
-\r
-#ifdef HAVE_FFTW\r
-bool\r
-ImageFile::fft (ImageFile& result) const\r
-{\r
-  if (m_nx != result.nx() || m_ny != result.ny()) {\r
-    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");\r
-    return false;\r
-  }\r
-\r
-  if (result.dataType() == Array2dFile::DATA_TYPE_REAL) {\r
-    if (! result.reallocRealToComplex ())\r
-      return false;\r
-  }\r
-\r
-  fftw_complex* in = new fftw_complex [m_nx * m_ny];\r
-\r
-  ImageFileArrayConst vReal = getArray();\r
-  ImageFileArrayConst vImag = getImaginaryArray();\r
-\r
-  unsigned int ix, iy;\r
-  unsigned int iArray = 0;\r
-  for (ix = 0; ix < m_nx; ix++)\r
-    for (iy = 0; iy < m_ny; iy++) {\r
-      in[iArray].re = vReal[ix][iy];\r
-      if (isComplex())\r
-        in[iArray].im = vImag[ix][iy];\r
-      else\r
-        in[iArray].im = 0;\r
-      iArray++;\r
-    }\r
-\r
-  fftwnd_plan plan = fftw2d_create_plan (m_nx, m_ny, FFTW_FORWARD, FFTW_IN_PLACE);\r
-\r
-  fftwnd_one (plan, in, NULL);\r
-\r
-  ImageFileArray vRealResult = result.getArray();\r
-  ImageFileArray vImagResult = result.getImaginaryArray();\r
-  iArray = 0;\r
-  unsigned int iScale = m_nx * m_ny;\r
-  for (ix = 0; ix < m_nx; ix++)\r
-    for (iy = 0; iy < m_ny; iy++) {\r
-      vRealResult[ix][iy] = in[iArray].re / iScale;\r
-      vImagResult[ix][iy] = in[iArray].im / iScale;\r
-      iArray++;\r
-    }\r
-\r
-  fftwnd_destroy_plan (plan);\r
-  delete in;\r
-\r
-\r
-  ProcessImage::shuffleFourierToNaturalOrder (result);\r
-\r
-  return true;\r
-}\r
-\r
-\r
-bool\r
-ImageFile::ifft (ImageFile& result) const\r
-{\r
-  if (m_nx != result.nx() || m_ny != result.ny()) {\r
-    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");\r
-    return false;\r
-  }\r
-\r
-  if (result.dataType() == Array2dFile::DATA_TYPE_REAL) {\r
-    if (! result.reallocRealToComplex ())\r
-      return false;\r
-  }\r
-\r
-  ImageFileArrayConst vReal = getArray();\r
-  ImageFileArrayConst vImag = getImaginaryArray();\r
-  ImageFileArray vRealResult = result.getArray();\r
-  ImageFileArray vImagResult = result.getImaginaryArray();\r
-  unsigned int ix, iy;\r
-  for (ix = 0; ix < m_nx; ix++)\r
-    for (iy = 0; iy < m_ny; iy++) {\r
-      vRealResult[ix][iy] = vReal[ix][iy];\r
-      if (isComplex()) \r
-        vImagResult[ix][iy] = vImag[ix][iy];\r
-      else\r
-        vImagResult[ix][iy] = 0;\r
-    }\r
-\r
-  ProcessImage::shuffleNaturalToFourierOrder (result);\r
-\r
-  fftw_complex* in = new fftw_complex [m_nx * m_ny];\r
-\r
-  unsigned int iArray = 0;\r
-  for (ix = 0; ix < m_nx; ix++)\r
-    for (iy = 0; iy < m_ny; iy++) {\r
-      in[iArray].re = vRealResult[ix][iy];\r
-      in[iArray].im = vImagResult[ix][iy];\r
-      iArray++;\r
-    }\r
-\r
-  fftwnd_plan plan = fftw2d_create_plan (m_nx, m_ny, FFTW_BACKWARD, FFTW_IN_PLACE);\r
-\r
-  fftwnd_one (plan, in, NULL);\r
-\r
-  iArray = 0;\r
-  for (ix = 0; ix < m_nx; ix++)\r
-    for (iy = 0; iy < m_ny; iy++) {\r
-      vRealResult[ix][iy] = in[iArray].re;\r
-      vImagResult[ix][iy] = in[iArray].im;\r
-      iArray++;\r
-    }\r
-\r
-  fftwnd_destroy_plan (plan);\r
-\r
-  delete in;\r
-\r
-  return true;\r
-}\r
-#endif // HAVE_FFTW\r
-\r
-\r
-  \r
-bool\r
-ImageFile::fourier (ImageFile& result) const\r
-{\r
-  if (m_nx != result.nx() || m_ny != result.ny()) {\r
-    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");\r
-    return false;\r
-  }\r
-  \r
-  if (result.dataType() == Array2dFile::DATA_TYPE_REAL) {\r
-    if (! result.reallocRealToComplex ())\r
-      return false;\r
-  }\r
-  \r
-  ImageFileArrayConst vLHS = getArray();\r
-  ImageFileArrayConst vLHSImag = getImaginaryArray();\r
-  ImageFileArray vRealResult = result.getArray();\r
-  ImageFileArray vImagResult = result.getImaginaryArray();\r
-  \r
-  unsigned int ix, iy;\r
-\r
-  // alloc output matrix\r
-  CTSimComplex** complexOut = new CTSimComplex* [m_nx];\r
-  for (ix = 0; ix < m_nx; ix++)\r
-    complexOut[ix] = new CTSimComplex [m_ny];\r
-  \r
-  // fourier each x column\r
-#if 1\r
-  CTSimComplex* pY = new CTSimComplex [m_ny];\r
-  for (ix = 0; ix < m_nx; ix++) {\r
-    for (iy = 0; iy < m_ny; iy++) {\r
-      pY[iy].real (vLHS[ix][iy]);\r
-      if (isComplex())\r
-        pY[iy].imag (vLHSImag[ix][iy]);\r
-      else\r
-        pY[iy].imag (0);\r
-    } \r
-    ProcessSignal::finiteFourierTransform (pY, complexOut[ix], m_ny,  ProcessSignal::FORWARD);\r
-  }\r
-#else\r
-  double* pY = new double [m_ny];\r
-  for (ix = 0; ix < m_nx; ix++) {\r
-    for (iy = 0; iy < m_ny; iy++) {\r
-      pY[iy] = vLHS[ix][iy];\r
-    } \r
-    ProcessSignal::finiteFourierTransform (pY, complexOut[ix], m_ny,  ProcessSignal::FORWARD);\r
-  }\r
-#endif\r
-  delete [] pY;\r
-  \r
-  // fourier each y row\r
-  CTSimComplex* pX = new CTSimComplex [m_nx];\r
-  CTSimComplex* complexOutRow = new CTSimComplex [m_nx];\r
-  for (iy = 0; iy < m_ny; iy++) {\r
-    for (ix = 0; ix < m_nx; ix++)\r
-      pX[ix] = complexOut[ix][iy];\r
-    ProcessSignal::finiteFourierTransform (pX, complexOutRow, m_nx, ProcessSignal::FORWARD);\r
-    for (ix = 0; ix < m_nx; ix++)\r
-      complexOut[ix][iy] = complexOutRow[ix];\r
-  }\r
-  delete [] pX;\r
-  \r
-  // shuffle each column\r
-  for (ix = 0; ix < m_nx; ix++)\r
-    ProcessSignal::shuffleFourierToNaturalOrder (complexOut[ix], m_ny);\r
-  \r
-  // shuffle each row\r
-  for (iy = 0; iy < m_ny; iy++) {\r
-    for (ix = 0; ix < m_nx; ix++)\r
-      complexOutRow[ix] = complexOut[ix][iy];\r
-    ProcessSignal::shuffleFourierToNaturalOrder (complexOutRow, m_nx);;\r
-    for (ix = 0; ix < m_nx; ix++)\r
-      complexOut[ix][iy] = complexOutRow[ix];\r
-    \r
-  }\r
-  delete [] complexOutRow;\r
-  \r
-  for (ix = 0; ix < m_nx; ix++)\r
-    for (iy = 0; iy < m_ny; iy++) {\r
-      vRealResult[ix][iy] = complexOut[ix][iy].real();\r
-      vImagResult[ix][iy] = complexOut[ix][iy].imag();\r
-    }\r
-    \r
-    for (ix = 0; ix < m_nx; ix++)\r
-      delete [] complexOut[ix];\r
-    delete [] complexOut;\r
-    \r
-    return true;\r
-}\r
-\r
-bool\r
-ImageFile::inverseFourier (ImageFile& result) const\r
-{\r
-  if (m_nx != result.nx() || m_ny != result.ny()) {\r
-    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");\r
-    return false;\r
-  }\r
-  \r
-  if (result.dataType() == Array2dFile::DATA_TYPE_REAL) {\r
-    if (! result.reallocRealToComplex ())\r
-      return false;\r
-  }\r
-  \r
-  ImageFileArrayConst vLHSReal = getArray();\r
-  ImageFileArrayConst vLHSImag = getImaginaryArray();\r
-  \r
-  unsigned int ix, iy;\r
-\r
-  // alloc 2d complex output matrix\r
-  CTSimComplex** complexOut = new CTSimComplex* [m_nx];\r
-  for (ix = 0; ix < m_nx; ix++)\r
-    complexOut[ix] = new CTSimComplex [m_ny];\r
-\r
-  // put input image into complexOut\r
-  for (ix = 0; ix < m_nx; ix++)\r
-    for (iy = 0; iy < m_ny; iy++) {\r
-      complexOut[ix][iy].real (vLHSReal[ix][iy]);\r
-      if (isComplex())\r
-        complexOut[ix][iy].imag (vLHSImag[ix][iy]);\r
-      else\r
-        complexOut[ix][iy].imag (0);\r
-    }\r
-\r
-  // shuffle each x column\r
-  for (ix = 0; ix < m_nx; ix++)\r
-    ProcessSignal::shuffleNaturalToFourierOrder (complexOut[ix], m_ny);\r
-\r
-  // shuffle each y row\r
-  CTSimComplex* pComplexRow = new CTSimComplex [m_nx];\r
-  for (iy = 0; iy < m_ny; iy++) {\r
-    for (ix = 0; ix < m_nx; ix++)\r
-      pComplexRow[ix] = complexOut[ix][iy];\r
-    ProcessSignal::shuffleNaturalToFourierOrder (pComplexRow, m_nx);\r
-    for (ix = 0; ix < m_nx; ix++)\r
-      complexOut[ix][iy] = pComplexRow[ix];\r
-  }\r
-  delete [] pComplexRow;\r
-\r
-  // ifourier each x column\r
-  CTSimComplex* pCol = new CTSimComplex [m_ny];\r
-  for (ix = 0; ix < m_nx; ix++) {\r
-    for (iy = 0; iy < m_ny; iy++)\r
-      pCol[iy] = complexOut[ix][iy];\r
-    ProcessSignal::finiteFourierTransform (pCol, complexOut[ix], m_ny,  ProcessSignal::BACKWARD);\r
-  }\r
-  delete [] pCol;\r
-\r
-  // ifourier each y row\r
-  CTSimComplex* complexInRow = new CTSimComplex [m_nx];\r
-  CTSimComplex* complexOutRow = new CTSimComplex [m_nx];\r
-  for (iy = 0; iy < m_ny; iy++) {\r
-    for (ix = 0; ix < m_nx; ix++)\r
-      complexInRow[ix] = complexOut[ix][iy];\r
-    ProcessSignal::finiteFourierTransform (complexInRow, complexOutRow, m_nx, ProcessSignal::BACKWARD);\r
-    for (ix = 0; ix < m_nx; ix++)\r
-      complexOut[ix][iy] = complexOutRow[ix];\r
-  }\r
-  delete [] complexInRow;\r
-  delete [] complexOutRow;\r
-\r
-  ImageFileArray vRealResult = result.getArray();\r
-  ImageFileArray vImagResult = result.getImaginaryArray();\r
-  for (ix = 0; ix < m_nx; ix++)\r
-    for (iy = 0; iy < m_ny; iy++) {\r
-      vRealResult[ix][iy] = complexOut[ix][iy].real();\r
-      vImagResult[ix][iy] = complexOut[ix][iy].imag();\r
-    }\r
-    \r
-  // delete complexOut matrix\r
-  for (ix = 0; ix < m_nx; ix++)\r
-    delete [] complexOut[ix];\r
-  delete [] complexOut;\r
-    \r
-  return true;\r
-}\r
-\r
-\r
-bool\r
-ImageFile::magnitude (ImageFile& result) const\r
-{\r
-  if (m_nx != result.nx() || m_ny != result.ny()) {\r
-    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");\r
-    return false;\r
-  }\r
-  \r
-  ImageFileArray vReal = getArray();\r
-  ImageFileArray vImag = getImaginaryArray();\r
-  \r
-  ImageFileArray vRealResult = result.getArray();\r
-  for (unsigned int ix = 0; ix < m_nx; ix++)\r
-    for (unsigned int iy = 0; iy < m_ny; iy++) {\r
-      if (isComplex()) \r
-        vRealResult[ix][iy] = ::sqrt (vReal[ix][iy] * vReal[ix][iy] + vImag[ix][iy] * vImag[ix][iy]);\r
-      else\r
-        vRealResult[ix][iy] = vReal[ix][iy];\r
-    }\r
-\r
-  if (result.isComplex())\r
-    result.reallocComplexToReal();\r
-  \r
-    return true;\r
-}\r
-\r
-bool\r
-ImageFile::phase (ImageFile& result) const\r
-{\r
-  if (m_nx != result.nx() || m_ny != result.ny()) {\r
-    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");\r
-    return false;\r
-  }\r
-  \r
-  ImageFileArray vReal = getArray();\r
-  ImageFileArray vImag = getImaginaryArray();\r
-  \r
-  ImageFileArray vRealResult = result.getArray();\r
-  for (unsigned int ix = 0; ix < m_nx; ix++)\r
-    for (unsigned int iy = 0; iy < m_ny; iy++) {\r
-      if (isComplex())\r
-        vRealResult[ix][iy] = ::atan2 (vImag[ix][iy], vReal[ix][iy]);\r
-      else\r
-        vRealResult[ix][iy] = 0;\r
-    }\r
-    \r
-  if (result.isComplex())\r
-    result.reallocComplexToReal();\r
-  \r
-  return true;\r
-}\r
-\r
-bool\r
-ImageFile::square (ImageFile& result) const\r
-{\r
-  if (m_nx != result.nx() || m_ny != result.ny()) {\r
-    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");\r
-    return false;\r
-  }\r
-  \r
-  ImageFileArrayConst vLHS = getArray();\r
-  ImageFileArray vResult = result.getArray();\r
-  \r
-  for (unsigned int ix = 0; ix < m_nx; ix++) {\r
-    ImageFileColumnConst in = vLHS[ix];\r
-    ImageFileColumn out = vResult[ix];\r
-    for (unsigned int iy = 0; iy < m_ny; iy++) {\r
-      *out++ = *in * *in;\r
-      in++;\r
-    }\r
-  }\r
-  \r
-  return true;\r
-}\r
-\r
-\r
-void 
-ImageFile::writeImagePGM (const char *outfile, int nxcell, int nycell, double densmin, double densmax)
+
+bool
+ImageFile::convertRealToComplex ()
 {
-  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<unsigned int> (dens * 255.);
-      }
-    }
-    for (int ir = 0; ir < nycell; ir++) {
-      for (int ic = 0; ic < nx * nxcell; ic++) 
-        fputc( rowp[ic], fp );
-    }
+  if (dataType() != Array2dFile::DATA_TYPE_REAL)
+    return false;
+
+  if (! reallocRealToComplex())
+    return false;
+
+  ImageFileArray vImag = getImaginaryArray();
+  for (unsigned int ix = 0; ix < m_nx; ix++) {
+    ImageFileColumn vCol = vImag[ix];
+    for (unsigned int iy = 0; iy < m_ny; iy++)
+      *vCol++ = 0;
   }
-  \r
-  delete rowp;
-  fclose(fp);
+
+  return true;
 }
 
-void 
-ImageFile::writeImagePGMASCII (const char *outfile, int nxcell, int nycell, double densmin, double densmax)
+bool
+ImageFile::convertComplexToReal ()
 {
-  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<unsigned int> (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");
+  if (dataType() != Array2dFile::DATA_TYPE_COMPLEX)
+    return false;
+
+  ImageFileArray vReal = getArray();
+  ImageFileArray vImag = getImaginaryArray();
+  for (unsigned int ix = 0; ix < m_nx; ix++) {
+    ImageFileColumn vRealCol = vReal[ix];
+    ImageFileColumn vImagCol = vImag[ix];
+    for (unsigned int iy = 0; iy < m_ny; iy++) {
+      CTSimComplex c (*vRealCol, *vImagCol);
+      *vRealCol++ = std::abs (c);
+      vImagCol++;
     }
   }
-  \r
-  delete rowp;
-  fclose(fp);
-}
 
+  return reallocComplexToReal();
+}
 
-#ifdef HAVE_PNG
-void 
-ImageFile::writeImagePNG (const char *outfile, int bitdepth, int nxcell, int nycell, double densmin, double densmax)
+bool
+ImageFile::subtractImages (const ImageFile& rRHS, ImageFile& result) const
 {
-  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;
+  if (m_nx != rRHS.nx() || m_ny != rRHS.ny() || m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::subtractImage]");
+    return false;
   }
-  
-  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<unsigned int> (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);
-        }
+
+  if (isComplex() || (rRHS.isComplex() && ! result.isComplex()))
+    result.convertRealToComplex();
+
+  ImageFileArrayConst vLHS = getArray();
+  ImageFileArrayConst vLHSImag = getImaginaryArray();
+  ImageFileArrayConst vRHS = rRHS.getArray();
+  ImageFileArrayConst vRHSImag = rRHS.getImaginaryArray();
+  ImageFileArray vResult = result.getArray();
+  ImageFileArray vResultImag = result.getImaginaryArray();
+
+  for (unsigned int ix = 0; ix < m_nx; ix++) {
+    for (unsigned int iy = 0; iy < m_ny; iy++) {
+      vResult[ix][iy] = vLHS[ix][iy] - vRHS[ix][iy];
+      if (result.isComplex()) {
+        vResultImag[ix][iy] = 0;
+        if (isComplex())
+          vResultImag[ix][iy] += vLHSImag[ix][iy];
+        if (rRHS.isComplex())
+          vResultImag[ix][iy] -= vRHSImag[ix][iy];
       }
     }
-    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;\r
-  
-  fclose(fp);
-}
-#endif
 
-#ifdef HAVE_GD
-#include "gd.h"
-static const int N_GRAYSCALE=256;
+  return true;
+}
 
-void
-ImageFile::writeImageGIF (const char *outfile, int nxcell, int nycell, double densmin, double densmax)
+bool
+ImageFile::addImages (const ImageFile& rRHS, ImageFile& result) const
 {
-  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 (m_nx != rRHS.nx() || m_ny != rRHS.ny() || m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::subtractImage]");
+    return false;
+  }
+
+  if (isComplex() || (rRHS.isComplex() && ! result.isComplex()))
+    result.convertRealToComplex();
+
+  ImageFileArrayConst vLHS = getArray();
+  ImageFileArrayConst vLHSImag = getImaginaryArray();
+  ImageFileArrayConst vRHS = rRHS.getArray();
+  ImageFileArrayConst vRHSImag = rRHS.getImaginaryArray();
+  ImageFileArray vResult = result.getArray();
+  ImageFileArray vResultImag = result.getImaginaryArray();
+
+  for (unsigned int ix = 0; ix < m_nx; ix++) {
+    for (unsigned int iy = 0; iy < m_ny; iy++) {
+      vResult[ix][iy] = vLHS[ix][iy] + vRHS[ix][iy];
+      if (result.isComplex()) {
+        vResultImag[ix][iy] = 0;
+        if (isComplex())
+          vResultImag[ix][iy] += vLHSImag[ix][iy];
+        if (rRHS.isComplex())
+          vResultImag[ix][iy] += vRHSImag[ix][iy];
       }
     }
   }
-  
-  if ((out = fopen(outfile,"w")) == NULL) {
-    sys_error(ERR_FATAL, "Error opening output file %s for writing", outfile);
-    return (1);
+
+  return true;
+}
+
+bool
+ImageFile::multiplyImages (const ImageFile& rRHS, ImageFile& result) const
+{
+  if (m_nx != rRHS.nx() || m_ny != rRHS.ny() || m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::subtractImage]");
+    return false;
+  }
+
+  if (isComplex() || (rRHS.isComplex() && ! result.isComplex()))
+    result.convertRealToComplex();
+
+  ImageFileArrayConst vLHS = getArray();
+  ImageFileArrayConst vLHSImag = getImaginaryArray();
+  ImageFileArrayConst vRHS = rRHS.getArray();
+  ImageFileArrayConst vRHSImag = rRHS.getImaginaryArray();
+  ImageFileArray vResult = result.getArray();
+  ImageFileArray vResultImag = result.getImaginaryArray();
+
+  for (unsigned int ix = 0; ix < m_nx; ix++) {
+    for (unsigned int iy = 0; iy < m_ny; iy++) {
+      if (result.isComplex()) {
+        double dImag = 0;
+        if (isComplex())
+          dImag = vLHSImag[ix][iy];
+        std::complex<double> cLHS (vLHS[ix][iy], dImag);
+        dImag = 0;
+        if (rRHS.isComplex())
+          dImag = vRHSImag[ix][iy];
+        std::complex<double> cRHS (vRHS[ix][iy], dImag);
+        std::complex<double> cResult = cLHS * cRHS;
+        vResult[ix][iy] = cResult.real();
+        vResultImag[ix][iy] = cResult.imag();
+      } else
+        vResult[ix][iy] = vLHS[ix][iy] * vRHS[ix][iy];
+    }
   }
-  gdImageGif(gif,out);
-  fclose(out);
-  gdImageDestroy(gif);
+
+
+  return true;
 }
-#endif
+
+bool
+ImageFile::divideImages (const ImageFile& rRHS, ImageFile& result) const
+{
+  if (m_nx != rRHS.nx() || m_ny != rRHS.ny() || m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::subtractImage]");
+    return false;
+  }
+
+  if (isComplex() || (rRHS.isComplex() && ! result.isComplex()))
+    result.convertRealToComplex();
+
+  ImageFileArrayConst vLHS = getArray();
+  ImageFileArrayConst vLHSImag = getImaginaryArray();
+  ImageFileArrayConst vRHS = rRHS.getArray();
+  ImageFileArrayConst vRHSImag = rRHS.getImaginaryArray();
+  ImageFileArray vResult = result.getArray();
+  ImageFileArray vResultImag = result.getImaginaryArray();
+
+  for (unsigned int ix = 0; ix < m_nx; ix++) {
+    for (unsigned int iy = 0; iy < m_ny; iy++) {
+      if (result.isComplex()) {
+        double dImag = 0;
+        if (isComplex())
+          dImag = vLHSImag[ix][iy];
+        std::complex<double> cLHS (vLHS[ix][iy], dImag);
+        dImag = 0;
+        if (rRHS.isComplex())
+          dImag = vRHSImag[ix][iy];
+        std::complex<double> cRHS (vRHS[ix][iy], dImag);
+        std::complex<double> cResult = cLHS / cRHS;
+        vResult[ix][iy] = cResult.real();
+        vResultImag[ix][iy] = cResult.imag();
+      } else {
+        if (vRHS != 0)
+          vResult[ix][iy] = vLHS[ix][iy] / vRHS[ix][iy];
+        else
+          vResult[ix][iy] = 0;
+      }
+    }
+  }
+
+  return true;
+}
+
+
+bool
+ImageFile::invertPixelValues (ImageFile& result) const
+{
+  if (m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");
+    return false;
+  }
+
+  if (isComplex() && ! result.isComplex())
+    result.convertRealToComplex();
+
+  ImageFileArrayConst vLHS = getArray();
+  ImageFileArray vResult = result.getArray();
+
+  for (unsigned int ix = 0; ix < m_nx; ix++) {
+    ImageFileColumnConst in = vLHS[ix];
+    ImageFileColumn out = vResult[ix];
+    for (unsigned int iy = 0; iy < m_ny; iy++)
+      *out++ = - *in++;
+  }
+
+  return true;
+}
+
+bool
+ImageFile::sqrt (ImageFile& result) const
+{
+  if (m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");
+    return false;
+  }
+
+  if (isComplex() && ! result.isComplex())
+    result.convertRealToComplex();
+
+  bool bComplexOutput = result.isComplex();
+  ImageFileArrayConst vLHS = getArray();
+  if (! bComplexOutput)   // check if should convert to complex output
+    for (unsigned int ix = 0; ix < m_nx; ix++)
+      for (unsigned int iy = 0; iy < m_ny; iy++)
+        if (! bComplexOutput && vLHS[ix][iy] < 0) {
+          result.convertRealToComplex();
+          bComplexOutput = true;
+          break;
+        }
+
+        ImageFileArrayConst vLHSImag = getImaginaryArray();
+        ImageFileArray vResult = result.getArray();
+        ImageFileArray vResultImag = result.getImaginaryArray();
+
+        for (unsigned int ix = 0; ix < m_nx; ix++) {
+          for (unsigned int iy = 0; iy < m_ny; iy++) {
+            if (result.isComplex()) {
+              double dImag = 0;
+              if (isComplex())
+                dImag = vLHSImag[ix][iy];
+              std::complex<double> cLHS (vLHS[ix][iy], dImag);
+              std::complex<double> cResult = std::sqrt(cLHS);
+              vResult[ix][iy] = cResult.real();
+              vResultImag[ix][iy] = cResult.imag();
+            } else
+              vResult[ix][iy] = ::sqrt (vLHS[ix][iy]);
+          }
+        }
+
+
+        return true;
+}
+
+bool
+ImageFile::log (ImageFile& result) const
+{
+  if (m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::log]");
+    return false;
+  }
+
+  if (isComplex() && ! result.isComplex())
+    result.convertRealToComplex();
+
+  ImageFileArrayConst vLHS = getArray();
+  ImageFileArrayConst vLHSImag = getImaginaryArray();
+  ImageFileArray vResult = result.getArray();
+  ImageFileArray vResultImag = result.getImaginaryArray();
+
+  for (unsigned int ix = 0; ix < m_nx; ix++) {
+    for (unsigned int iy = 0; iy < m_ny; iy++) {
+      if (result.isComplex()) {
+        double dImag = 0;
+        if (isComplex())
+          dImag = vLHSImag[ix][iy];
+        std::complex<double> cLHS (vLHS[ix][iy], dImag);
+        std::complex<double> cResult = std::log (cLHS);
+        vResult[ix][iy] = cResult.real();
+        vResultImag[ix][iy] = cResult.imag();
+      } else {
+        if (vLHS[ix][iy] > 0)
+          vResult[ix][iy] = ::log (vLHS[ix][iy]);
+        else
+          vResult[ix][iy] = 0;
+      }
+    }
+  }
+
+
+  return true;
+}
+
+bool
+ImageFile::exp (ImageFile& result) const
+{
+  if (m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");
+    return false;
+  }
+
+  if (isComplex() && ! result.isComplex())
+    result.convertRealToComplex();
+
+  ImageFileArrayConst vLHS = getArray();
+  ImageFileArrayConst vLHSImag = getImaginaryArray();
+  ImageFileArray vResult = result.getArray();
+  ImageFileArray vResultImag = result.getImaginaryArray();
+
+  for (unsigned int ix = 0; ix < m_nx; ix++) {
+    for (unsigned int iy = 0; iy < m_ny; iy++) {
+      if (result.isComplex()) {
+        double dImag = 0;
+        if (isComplex())
+          dImag = vLHSImag[ix][iy];
+        std::complex<double> cLHS (vLHS[ix][iy], dImag);
+        std::complex<double> cResult = std::exp (cLHS);
+        vResult[ix][iy] = cResult.real();
+        vResultImag[ix][iy] = cResult.imag();
+      } else
+        vResult[ix][iy] = ::exp (vLHS[ix][iy]);
+    }
+  }
+
+
+  return true;
+}
+
+bool
+ImageFile::scaleImage (ImageFile& result) const
+{
+  unsigned int nx = m_nx;
+  unsigned int ny = m_ny;
+  unsigned int newNX = result.nx();
+  unsigned int newNY = result.ny();
+
+  double dXScale = static_cast<double>(newNX) / static_cast<double>(nx);
+  double dYScale = static_cast<double>(newNY) / static_cast<double>(ny);
+
+  if (isComplex() && ! result.isComplex())
+    result.convertRealToComplex();
+
+  ImageFileArrayConst vReal = getArray();
+  ImageFileArrayConst vImag = getImaginaryArray();
+  ImageFileArray vResult = result.getArray();
+  ImageFileArray vResultImag = result.getImaginaryArray();
+
+  BilinearInterpolator<ImageFileValue> realInterp (vReal, nx, ny);
+  BilinearInterpolator<ImageFileValue> imagInterp (vImag, nx, ny);
+
+  for (unsigned int ix = 0; ix < newNX; ix++) {
+    for (unsigned int iy = 0; iy < newNY; iy++) {
+      double dXPos = ix / dXScale;
+      double dYPos = iy / dYScale;
+      vResult[ix][iy] = realInterp.interpolate (dXPos, dYPos);
+      if (result.isComplex()) {
+        if (isComplex()) {
+          vResultImag[ix][iy] = imagInterp.interpolate (dXPos, dYPos);
+        } else {
+          vResultImag[ix][iy] = 0;
+        }
+      }
+    }
+  }
+
+  return true;
+}
+
+#ifdef HAVE_FFTW
+bool
+ImageFile::fft (ImageFile& result) const
+{
+  if (m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");
+    return false;
+  }
+
+  if (result.dataType() == Array2dFile::DATA_TYPE_REAL) {
+    if (! result.convertRealToComplex ())
+      return false;
+  }
+
+  fftw_complex* in = static_cast<fftw_complex*> (fftw_malloc (sizeof(fftw_complex) * m_nx * m_ny));
+
+  ImageFileArrayConst vReal = getArray();
+  ImageFileArrayConst vImag = getImaginaryArray();
+
+  unsigned int ix, iy;
+  unsigned int iArray = 0;
+  for (ix = 0; ix < m_nx; ix++) {
+    for (iy = 0; iy < m_ny; iy++) {
+      in[iArray][0] = vReal[ix][iy];
+      if (isComplex())
+        in[iArray][1] = vImag[ix][iy];
+      else
+        in[iArray][1] = 0;
+      iArray++;
+    }
+  }
+
+  fftw_plan plan = fftw_plan_dft_2d (m_nx, m_ny, in, in, FFTW_FORWARD, FFTW_ESTIMATE);
+  fftw_execute (plan);
+
+  ImageFileArray vRealResult = result.getArray();
+  ImageFileArray vImagResult = result.getImaginaryArray();
+  iArray = 0;
+  unsigned int iScale = m_nx * m_ny;
+  for (ix = 0; ix < m_nx; ix++) {
+    for (iy = 0; iy < m_ny; iy++) {
+      vRealResult[ix][iy] = in[iArray][0] / iScale;
+      vImagResult[ix][iy] = in[iArray][1] / iScale;
+      iArray++;
+    }
+  }
+  fftw_free(in);
+  fftw_destroy_plan (plan);
+
+  Fourier::shuffleFourierToNaturalOrder (result);
+
+  return true;
+}
+
+
+bool
+ImageFile::ifft (ImageFile& result) const
+{
+  if (m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");
+    return false;
+  }
+
+  if (result.dataType() == Array2dFile::DATA_TYPE_REAL) {
+    if (! result.convertRealToComplex ())
+      return false;
+  }
+
+  ImageFileArrayConst vReal = getArray();
+  ImageFileArrayConst vImag = getImaginaryArray();
+  ImageFileArray vRealResult = result.getArray();
+  ImageFileArray vImagResult = result.getImaginaryArray();
+  unsigned int ix, iy;
+  for (ix = 0; ix < m_nx; ix++) {
+    for (iy = 0; iy < m_ny; iy++) {
+      vRealResult[ix][iy] = vReal[ix][iy];
+      if (isComplex())
+        vImagResult[ix][iy] = vImag[ix][iy];
+      else
+        vImagResult[ix][iy] = 0;
+    }
+  }
+
+  Fourier::shuffleNaturalToFourierOrder (result);
+
+  fftw_complex* in = static_cast<fftw_complex*>(fftw_malloc(sizeof(fftw_complex) * m_nx * m_ny));
+
+  unsigned int iArray = 0;
+  for (ix = 0; ix < m_nx; ix++) {
+    for (iy = 0; iy < m_ny; iy++) {
+      in[iArray][0] = vRealResult[ix][iy];
+      in[iArray][1] = vImagResult[ix][iy];
+      iArray++;
+    }
+  }
+
+  fftw_plan plan = fftw_plan_dft_2d (m_nx, m_ny, in, in, FFTW_BACKWARD, FFTW_ESTIMATE);
+
+  fftw_execute (plan);
+
+  iArray = 0;
+  for (ix = 0; ix < m_nx; ix++) {
+    for (iy = 0; iy < m_ny; iy++) {
+      vRealResult[ix][iy] = in[iArray][0];
+      vImagResult[ix][iy] = in[iArray][1];
+      iArray++;
+    }
+  }
+  fftw_destroy_plan (plan);
+  fftw_free(in);
+
+  return true;
+}
+
+bool
+ImageFile::fftRows (ImageFile& result) const
+{
+  if (m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::fftRows]");
+    return false;
+  }
+
+  if (result.dataType() == Array2dFile::DATA_TYPE_REAL) {
+    if (! result.convertRealToComplex ())
+      return false;
+  }
+
+  ImageFileArrayConst vReal = getArray();
+  ImageFileArrayConst vImag = getImaginaryArray();
+
+  fftw_complex* in = static_cast<fftw_complex*>(fftw_malloc(sizeof(fftw_complex) * m_nx));
+  fftw_plan plan = fftw_plan_dft_1d (m_nx, in, in, FFTW_FORWARD, FFTW_ESTIMATE);
+
+  std::complex<double>* pcRow = new std::complex<double> [m_nx];
+  for (unsigned int iy = 0; iy < m_ny; iy++) {
+    unsigned int ix;
+    for (ix = 0; ix < m_nx; ix++) {
+      in[ix][0] = vReal[ix][iy];
+      if (isComplex())
+        in[ix][1] = vImag[ix][iy];
+      else
+        in[ix][1] = 0;
+    }
+
+    fftw_execute (plan);
+
+    for (ix = 0; ix < m_nx; ix++)
+      pcRow[ix] = std::complex<double>(in[ix][0], in[ix][1]);
+
+    Fourier::shuffleFourierToNaturalOrder (pcRow, m_nx);
+    for (ix = 0; ix < m_nx; ix++) {
+      vReal[ix][iy] = pcRow[ix].real() / m_nx;
+      vImag[ix][iy] = pcRow[ix].imag() / m_nx;
+    }
+  }
+  delete [] pcRow;
+
+  fftw_destroy_plan (plan);
+  fftw_free(in);
+
+  return true;
+}
+
+bool
+ImageFile::ifftRows (ImageFile& result) const
+{
+  if (m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::fftRows]");
+    return false;
+  }
+
+  if (result.dataType() == Array2dFile::DATA_TYPE_REAL) {
+    if (! result.convertRealToComplex ())
+      return false;
+  }
+
+  ImageFileArrayConst vReal = getArray();
+  ImageFileArrayConst vImag = getImaginaryArray();
+
+  fftw_complex* in = static_cast<fftw_complex*>(fftw_malloc(sizeof(fftw_complex) * m_nx));
+  fftw_plan plan = fftw_plan_dft_1d (m_nx, in, in, FFTW_BACKWARD, FFTW_ESTIMATE);
+  std::complex<double>* pcRow = new std::complex<double> [m_nx];
+
+  unsigned int ix, iy;
+  // unsigned int iArray = 0;
+  for (iy = 0; iy < m_ny; iy++) {
+    for (ix = 0; ix < m_nx; ix++) {
+      double dImag = 0;
+      if (isComplex())
+        dImag = vImag[ix][iy];
+      pcRow[ix] = std::complex<double> (vReal[ix][iy], dImag);
+    }
+
+    Fourier::shuffleNaturalToFourierOrder (pcRow, m_nx);
+
+    for (ix = 0; ix < m_nx; ix++) {
+      in[ix][0] = pcRow[ix].real();
+      in[ix][1] = pcRow[ix].imag();
+    }
+
+    fftw_execute (plan);
+
+    for (ix = 0; ix < m_nx; ix++) {
+      vReal[ix][iy] = in[ix][0];
+      vImag[ix][iy] = in[ix][1];
+    }
+  }
+  delete [] pcRow;
+
+  fftw_destroy_plan (plan);
+  fftw_free(in);
+
+  return true;
+}
+
+bool
+ImageFile::fftCols (ImageFile& result) const
+{
+  if (m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::fftRows]");
+    return false;
+  }
+
+  if (result.dataType() == Array2dFile::DATA_TYPE_REAL) {
+    if (! result.convertRealToComplex ())
+      return false;
+  }
+
+  ImageFileArrayConst vReal = getArray();
+  ImageFileArrayConst vImag = getImaginaryArray();
+
+  fftw_complex* in = static_cast<fftw_complex*>(fftw_malloc(sizeof(fftw_complex) * m_ny));
+  fftw_plan plan = fftw_plan_dft_1d (m_ny, in, in, FFTW_FORWARD, FFTW_ESTIMATE);
+
+  std::complex<double>* pcCol = new std::complex<double> [m_ny];
+  for (unsigned int ix = 0; ix < m_nx; ix++) {
+    unsigned int iy;
+    for (iy = 0; iy < m_ny; iy++) {
+      in[iy][0] = vReal[ix][iy];
+      if (isComplex())
+        in[iy][1] = vImag[ix][iy];
+      else
+        in[iy][1] = 0;
+    }
+
+    fftw_execute (plan);
+
+    for (iy = 0; iy < m_ny; iy++)
+      pcCol[iy] = std::complex<double>(in[iy][0], in[iy][1]);
+
+    Fourier::shuffleFourierToNaturalOrder (pcCol, m_ny);
+    for (iy = 0; iy < m_ny; iy++) {
+      vReal[ix][iy] = pcCol[iy].real() / m_ny;
+      vImag[ix][iy] = pcCol[iy].imag() / m_ny;
+    }
+  }
+  delete [] pcCol;
+
+  fftw_destroy_plan (plan);
+  fftw_free(in);
+
+  return true;
+}
+
+bool
+ImageFile::ifftCols (ImageFile& result) const
+{
+  if (m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::fftRows]");
+    return false;
+  }
+
+  if (result.dataType() == Array2dFile::DATA_TYPE_REAL) {
+    if (! result.convertRealToComplex ())
+      return false;
+  }
+
+  ImageFileArrayConst vReal = getArray();
+  ImageFileArrayConst vImag = getImaginaryArray();
+
+  fftw_complex* in = static_cast<fftw_complex*>(fftw_malloc(sizeof(fftw_complex) * m_ny));
+  fftw_plan plan = fftw_plan_dft_1d (m_ny, in, in, FFTW_BACKWARD, FFTW_ESTIMATE);
+  std::complex<double>* pcCol = new std::complex<double> [m_ny];
+
+  unsigned int ix, iy;
+  // unsigned int iArray = 0;
+  for (ix = 0; ix < m_nx; ix++) {
+    for (iy = 0; iy < m_ny; iy++) {
+      double dImag = 0;
+      if (isComplex())
+        dImag = vImag[ix][iy];
+      pcCol[iy] = std::complex<double> (vReal[ix][iy], dImag);
+    }
+
+    Fourier::shuffleNaturalToFourierOrder (pcCol, m_ny);
+
+    for (iy = 0; iy < m_ny; iy++) {
+      in[iy][0] = pcCol[iy].real();
+      in[iy][1] = pcCol[iy].imag();
+    }
+
+    fftw_execute (plan);
+
+    for (iy = 0; iy < m_ny; iy++) {
+      vReal[ix][iy] = in[iy][0];
+      vImag[ix][iy] = in[iy][1];
+    }
+  }
+  delete [] pcCol;
+
+  fftw_destroy_plan (plan);
+  fftw_free(in);
+
+  return true;
+}
+
+#endif // HAVE_FFTW
+
+
+
+bool
+ImageFile::fourier (ImageFile& result) const
+{
+  if (m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");
+    return false;
+  }
+
+  if (! result.isComplex())
+    if (! result.convertRealToComplex ())
+      return false;
+
+    ImageFileArrayConst vLHS = getArray();
+    ImageFileArrayConst vLHSImag = getImaginaryArray();
+    ImageFileArray vRealResult = result.getArray();
+    ImageFileArray vImagResult = result.getImaginaryArray();
+
+    unsigned int ix, iy;
+
+    // alloc output matrix
+    CTSimComplex** complexOut = new CTSimComplex* [m_nx];
+    for (ix = 0; ix < m_nx; ix++)
+      complexOut[ix] = new CTSimComplex [m_ny];
+
+    // fourier each x column
+    CTSimComplex* pY = new CTSimComplex [m_ny];
+    for (ix = 0; ix < m_nx; ix++) {
+      for (iy = 0; iy < m_ny; iy++) {
+        double dImag = 0;
+        if (isComplex())
+          dImag = vLHSImag[ix][iy];
+        pY[iy] = std::complex<double>(vLHS[ix][iy], dImag);
+      }
+      ProcessSignal::finiteFourierTransform (pY, complexOut[ix], m_ny,  ProcessSignal::FORWARD);
+    }
+    delete [] pY;
+
+    // fourier each y row
+    CTSimComplex* pX = new CTSimComplex [m_nx];
+    CTSimComplex* complexOutRow = new CTSimComplex [m_nx];
+    for (iy = 0; iy < m_ny; iy++) {
+      for (ix = 0; ix < m_nx; ix++)
+        pX[ix] = complexOut[ix][iy];
+      ProcessSignal::finiteFourierTransform (pX, complexOutRow, m_nx, ProcessSignal::FORWARD);
+      for (ix = 0; ix < m_nx; ix++)
+        complexOut[ix][iy] = complexOutRow[ix];
+    }
+    delete [] pX;
+    delete [] complexOutRow;
+
+    for (ix = 0; ix < m_nx; ix++)
+      for (iy = 0; iy < m_ny; iy++) {
+        vRealResult[ix][iy] = complexOut[ix][iy].real();
+        vImagResult[ix][iy] = complexOut[ix][iy].imag();
+      }
+
+      Fourier::shuffleFourierToNaturalOrder (result);
+
+      // delete complexOut matrix
+      for (ix = 0; ix < m_nx; ix++)
+        delete [] complexOut[ix];
+      delete [] complexOut;
+
+      return true;
+}
+
+bool
+ImageFile::inverseFourier (ImageFile& result) const
+{
+  if (m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");
+    return false;
+  }
+
+  if (result.dataType() == Array2dFile::DATA_TYPE_REAL) {
+    if (! result.convertRealToComplex ())
+      return false;
+  }
+
+  ImageFileArrayConst vLHSReal = getArray();
+  ImageFileArrayConst vLHSImag = getImaginaryArray();
+  ImageFileArray vRealResult = result.getArray();
+  ImageFileArray vImagResult = result.getImaginaryArray();
+
+  unsigned int ix, iy;
+  // alloc 2d complex output matrix
+  CTSimComplex** complexOut = new CTSimComplex* [m_nx];
+  for (ix = 0; ix < m_nx; ix++)
+    complexOut[ix] = new CTSimComplex [m_ny];
+
+  // put input image into result
+  for (ix = 0; ix < m_nx; ix++)
+    for (iy = 0; iy < m_ny; iy++) {
+      vRealResult[ix][iy] = vLHSReal[ix][iy];
+      if (isComplex())
+        vImagResult[ix][iy] = vLHSImag[ix][iy];
+      else
+        vImagResult[ix][iy] = 0;
+    }
+
+    Fourier::shuffleNaturalToFourierOrder (result);
+
+    // ifourier each x column
+    CTSimComplex* pCol = new CTSimComplex [m_ny];
+    for (ix = 0; ix < m_nx; ix++) {
+      for (iy = 0; iy < m_ny; iy++) {
+        pCol[iy] = std::complex<double> (vRealResult[ix][iy], vImagResult[ix][iy]);
+      }
+      ProcessSignal::finiteFourierTransform (pCol, complexOut[ix], m_ny,  ProcessSignal::BACKWARD);
+    }
+    delete [] pCol;
+
+    // ifourier each y row
+    CTSimComplex* complexInRow = new CTSimComplex [m_nx];
+    CTSimComplex* complexOutRow = new CTSimComplex [m_nx];
+    for (iy = 0; iy < m_ny; iy++) {
+      for (ix = 0; ix < m_nx; ix++)
+        complexInRow[ix] = complexOut[ix][iy];
+      ProcessSignal::finiteFourierTransform (complexInRow, complexOutRow, m_nx, ProcessSignal::BACKWARD);
+      for (ix = 0; ix < m_nx; ix++)
+        complexOut[ix][iy] = complexOutRow[ix];
+    }
+    delete [] complexInRow;
+    delete [] complexOutRow;
+
+    for (ix = 0; ix < m_nx; ix++)
+      for (iy = 0; iy < m_ny; iy++) {
+        vRealResult[ix][iy] = complexOut[ix][iy].real();
+        vImagResult[ix][iy] = complexOut[ix][iy].imag();
+      }
+
+      // delete complexOut matrix
+      for (ix = 0; ix < m_nx; ix++)
+        delete [] complexOut[ix];
+      delete [] complexOut;
+
+      return true;
+}
+
+
+bool
+ImageFile::magnitude (ImageFile& result) const
+{
+  if (m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");
+    return false;
+  }
+
+  ImageFileArray vReal = getArray();
+  ImageFileArray vImag = getImaginaryArray();
+  ImageFileArray vRealResult = result.getArray();
+
+  for (unsigned int ix = 0; ix < m_nx; ix++)
+    for (unsigned int iy = 0; iy < m_ny; iy++) {
+      if (isComplex())
+        vRealResult[ix][iy] = ::sqrt (vReal[ix][iy] * vReal[ix][iy] + vImag[ix][iy] * vImag[ix][iy]);
+      else
+        vRealResult[ix][iy] = ::fabs(vReal[ix][iy]);
+    }
+
+    if (result.isComplex())
+      result.reallocComplexToReal();
+
+    return true;
+}
+
+bool
+ImageFile::phase (ImageFile& result) const
+{
+  if (m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");
+    return false;
+  }
+
+  ImageFileArray vReal = getArray();
+  ImageFileArray vImag = getImaginaryArray();
+  ImageFileArray vRealResult = result.getArray();
+
+  for (unsigned int ix = 0; ix < m_nx; ix++) {
+    for (unsigned int iy = 0; iy < m_ny; iy++) {
+      if (isComplex())
+        vRealResult[ix][iy] = ::atan2 (vImag[ix][iy], vReal[ix][iy]);
+      else
+        vRealResult[ix][iy] = 0;
+    }
+  }
+  if (result.isComplex())
+    result.reallocComplexToReal();
+
+  return true;
+}
+
+bool
+ImageFile::real (ImageFile& result) const
+{
+  if (m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");
+    return false;
+  }
+
+  ImageFileArray vReal = getArray();
+  ImageFileArray vRealResult = result.getArray();
+
+  for (unsigned int ix = 0; ix < m_nx; ix++) {
+    for (unsigned int iy = 0; iy < m_ny; iy++) {
+        vRealResult[ix][iy] = vReal[ix][iy];
+    }
+  }
+
+  if (result.isComplex())
+    result.reallocComplexToReal();
+
+  return true;
+}
+
+bool
+ImageFile::imaginary (ImageFile& result) const
+{
+  if (m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");
+    return false;
+  }
+
+  ImageFileArray vImag = getArray();
+  ImageFileArray vRealResult = result.getArray();
+
+  for (unsigned int ix = 0; ix < m_nx; ix++) {
+    for (unsigned int iy = 0; iy < m_ny; iy++) {
+      if (isComplex())
+        vRealResult[ix][iy] = vImag[ix][iy];
+      else
+        vRealResult[ix][iy] = 0;
+    }
+  }
+
+  if (result.isComplex())
+      result.reallocComplexToReal();
+
+  return true;
+}
+
+bool
+ImageFile::square (ImageFile& result) const
+{
+  if (m_nx != result.nx() || m_ny != result.ny()) {
+    sys_error (ERR_WARNING, "Difference sizes of images [ImageFile::invertPixelValues]");
+    return false;
+  }
+
+  if (isComplex() && ! result.isComplex())
+    result.convertRealToComplex();
+
+  ImageFileArrayConst vLHS = getArray();
+  ImageFileArrayConst vLHSImag = getImaginaryArray();
+  ImageFileArray vResult = result.getArray();
+  ImageFileArray vResultImag = result.getImaginaryArray();
+
+  for (unsigned int ix = 0; ix < m_nx; ix++) {
+    for (unsigned int iy = 0; iy < m_ny; iy++) {
+      if (result.isComplex()) {
+        double dImag = 0;
+        if (isComplex())
+          dImag = vLHSImag[ix][iy];
+        std::complex<double> cLHS (vLHS[ix][iy], dImag);
+        std::complex<double> cResult = cLHS * cLHS;
+        vResult[ix][iy] = cResult.real();
+        vResultImag[ix][iy] = cResult.imag();
+      } else
+        vResult[ix][iy] = vLHS[ix][iy] * vLHS[ix][iy];
+    }
+  }
+
+  return true;
+}
+
+int
+ImageFile::convertExportFormatNameToID (const char* const formatName)
+{
+  int formatID = EXPORT_FORMAT_INVALID;
+
+  for (int i = 0; i < s_iExportFormatCount; i++)
+    if (strcasecmp (formatName, s_aszExportFormatName[i]) == 0) {
+      formatID = i;
+      break;
+    }
+
+    return (formatID);
+}
+
+const char*
+ImageFile::convertExportFormatIDToName (int formatID)
+{
+  static const char *formatName = "";
+
+  if (formatID >= 0 && formatID < s_iExportFormatCount)
+    return (s_aszExportFormatName[formatID]);
+
+  return (formatName);
+}
+
+const char*
+ImageFile::convertExportFormatIDToTitle (const int formatID)
+{
+  static const char *formatTitle = "";
+
+  if (formatID >= 0 && formatID < s_iExportFormatCount)
+    return (s_aszExportFormatTitle[formatID]);
+
+  return (formatTitle);
+}
+
+int
+ImageFile::convertImportFormatNameToID (const char* const formatName)
+{
+  int formatID = IMPORT_FORMAT_INVALID;
+
+  for (int i = 0; i < s_iImportFormatCount; i++)
+    if (strcasecmp (formatName, s_aszImportFormatName[i]) == 0) {
+      formatID = i;
+      break;
+    }
+
+    return (formatID);
+}
+
+const char*
+ImageFile::convertImportFormatIDToName (int formatID)
+{
+  static const char *formatName = "";
+
+  if (formatID >= 0 && formatID < s_iImportFormatCount)
+    return (s_aszImportFormatName[formatID]);
+
+  return (formatName);
+}
+
+const char*
+ImageFile::convertImportFormatIDToTitle (const int formatID)
+{
+  static const char *formatTitle = "";
+
+  if (formatID >= 0 && formatID < s_iImportFormatCount)
+    return (s_aszImportFormatTitle[formatID]);
+
+  return (formatTitle);
+}
+
+bool
+ImageFile::importImage (const char* const pszFormat, const char* const pszFilename)
+{
+  int iFormatID = convertImportFormatNameToID (pszFormat);
+
+  if (iFormatID == IMPORT_FORMAT_PPM)
+    return readImagePPM (pszFilename);
+#ifdef HAVE_PNG
+  else if (iFormatID == IMPORT_FORMAT_PNG)
+    return readImagePNG (pszFilename);
+#endif
+
+  sys_error (ERR_SEVERE, "Invalid format %s [ImageFile::importImage]", pszFormat);
+  return false;
+}
+
+void
+ImageFile::skipSpacePPM (FILE* fp)
+{
+  int c = fgetc (fp);
+  while (isspace (c) || c == '#') {
+    if (c == '#') {   // comment until end of line
+      c = fgetc(fp);
+      while (c != 13 && c != 10)
+        c = fgetc(fp);
+    }
+    else
+      c = fgetc(fp);
+  }
+
+  ungetc (c, fp);
+}
+
+bool
+ImageFile::readImagePPM (const char* const pszFile)
+{
+  FILE* fp = fopen (pszFile, "r");
+  if ((fp = fopen (pszFile, "r")) == NULL)
+    return false;
+  char cSignature = toupper(fgetc(fp));
+  if (cSignature != 'P') {
+    fclose(fp);
+    return false;
+  }
+  cSignature = fgetc(fp);
+  if (cSignature == '5' || cSignature == '6') { // binary modes
+    fclose(fp);
+    fp = fopen(pszFile, "rb"); // reopen in binary mode
+    fgetc(fp);
+    fgetc(fp);
+  } else if (cSignature != '2' && cSignature != '3') {
+    fclose(fp);
+    return false;
+  }
+
+  int nRows, nCols, iMaxValue;
+  skipSpacePPM (fp);
+  if (fscanf (fp, "%d", &nCols) != 1) {
+    fclose(fp);
+    return false;
+  }
+  skipSpacePPM (fp);
+  if (fscanf (fp, "%d", &nRows) != 1) {
+    fclose(fp);
+    return false;
+  }
+  skipSpacePPM (fp);
+  if (fscanf (fp, "%d", &iMaxValue) != 1) {
+    fclose(fp);
+    return false;
+  }
+  setArraySize (nRows, nCols);
+
+  if (cSignature == '5' || cSignature == '6') { // binary modes
+    int c = fgetc(fp);
+    if (c == 13) {
+      c = fgetc(fp);
+      if (c != 10)  // read msdos 13-10 newline
+        ungetc(c, fp);
+    }
+  } else
+    skipSpacePPM (fp); // ascii may have comments
+
+  bool bMonochromeImage = false;
+  double dMaxValue = iMaxValue;
+  double dMaxValue3 = iMaxValue * 3;
+
+  ImageFileArray v = getArray();
+  for (int iy = nRows - 1; iy >= 0; iy--) {
+    for (int ix = 0; ix < nCols; ix++) {
+      int iGS, iR, iG, iB;
+      double dR, dG, dB;
+      switch (cSignature) {
+      case '2':
+        if (fscanf(fp, "%d ", &iGS) != 1) {
+          fclose(fp);
+          return false;
+        }
+        v[ix][iy] = iGS / dMaxValue;
+        break;
+      case '5':
+        iGS = fgetc(fp);
+        if (iGS == EOF) {
+          fclose(fp);
+          return false;
+        }
+        v[ix][iy] = iGS / dMaxValue;
+        break;
+      case '3':
+        if (fscanf (fp, "%d %d %d ", &iR, &iG, &iB) != 3) {
+          fclose(fp);
+          return false;
+        }
+        if (ix == 0 && iy == 0 && (iR == iG && iG == iB))
+          bMonochromeImage = true;
+        if (bMonochromeImage)
+          v[ix][iy] = (iR + iG + iB) / dMaxValue3;
+        else {
+          dR = iR / dMaxValue;
+          dG = iG / dMaxValue;
+          dB = iB / dMaxValue;
+          v[ix][iy] = colorToGrayscale (dR, dG, dB);
+        }
+        break;
+      case '6':
+        iR = fgetc(fp);
+        iG = fgetc(fp);
+        iB = fgetc(fp);
+
+        if (iB == EOF) {
+          fclose(fp);
+          return false;
+        }
+        if (ix == 0 && iy == 0 && (iR == iG && iG == iB))
+          bMonochromeImage = true;
+
+        if (bMonochromeImage)
+          v[ix][iy] = (iR + iG + iB) / dMaxValue3;
+        else {
+          dR = iR / dMaxValue;
+          dG = iG / dMaxValue;
+          dB = iB / dMaxValue;
+          v[ix][iy] = colorToGrayscale (dR, dG, dB);
+        }
+        break;
+      }
+    }
+  }
+
+  fclose(fp);
+  return true;
+}
+
+#ifdef HAVE_PNG
+bool
+ImageFile::readImagePNG (const char* const pszFile)
+{
+  FILE* fp = fopen(pszFile, "rb");
+  if (!fp)
+    return false;
+  unsigned char header[8];
+  fread (header, 1, 8, fp);
+  if (png_sig_cmp (header, 0, 8)) {
+    fclose (fp);
+    return false;
+  }
+
+  png_structp png_ptr = png_create_read_struct (PNG_LIBPNG_VER_STRING, NULL, NULL, NULL);
+  if (!png_ptr) {
+    fclose(fp);
+    return false;
+  }
+
+  png_infop info_ptr = png_create_info_struct(png_ptr);
+  if (!info_ptr) {
+    png_destroy_read_struct(&png_ptr, (png_infopp)NULL, (png_infopp)NULL);
+    fclose(fp);
+    return false;
+  }
+
+  png_infop end_info = png_create_info_struct(png_ptr);
+  if (!end_info) {
+    png_destroy_read_struct(&png_ptr, &info_ptr, (png_infopp)NULL);
+    fclose(fp);
+    return false;
+  }
+
+  if (setjmp(png_ptr->jmpbuf)) {
+    png_destroy_read_struct(&png_ptr, &info_ptr, &end_info);
+    fclose(fp);
+    return false;
+  }
+
+  png_init_io(png_ptr, fp);
+  png_set_sig_bytes(png_ptr, 8);
+  png_read_info(png_ptr, info_ptr);
+
+  int width = png_get_image_width (png_ptr, info_ptr);
+  int height = png_get_image_height (png_ptr, info_ptr);
+  int bit_depth = png_get_bit_depth (png_ptr, info_ptr);
+  int color_type = png_get_color_type (png_ptr, info_ptr);
+
+  if (color_type == PNG_COLOR_TYPE_PALETTE && bit_depth <= 8)
+    png_set_expand(png_ptr);
+
+  if (color_type == PNG_COLOR_TYPE_GRAY && bit_depth < 8)
+    png_set_expand(png_ptr);
+
+  if (bit_depth < 8)
+    png_set_packing(png_ptr);
+
+  if (color_type & PNG_COLOR_MASK_ALPHA)
+    png_set_strip_alpha(png_ptr);
+
+  if (bit_depth == 16)
+    png_set_swap(png_ptr); // convert to little-endian format
+
+  png_read_update_info(png_ptr, info_ptr); // update with transformations
+  int rowbytes = png_get_rowbytes (png_ptr, info_ptr);
+  bit_depth = png_get_bit_depth (png_ptr, info_ptr);
+  color_type = png_get_color_type (png_ptr, info_ptr);
+
+  png_bytep* row_pointers = new png_bytep [height];
+  int i;
+  for (i = 0; i < height; i++)
+    row_pointers[i] = new unsigned char [rowbytes];
+
+  png_read_image(png_ptr, row_pointers);
+
+  setArraySize (width, height);
+  ImageFileArray v = getArray();
+  for (int iy = 0; iy < height; iy++) {
+    for (int ix = 0; ix < width; ix++) {
+      double dV = 0;
+      if (color_type == PNG_COLOR_TYPE_GRAY) {
+        if (bit_depth == 8)
+          dV = row_pointers[iy][ix] / 255.;
+        else if (bit_depth == 16) {
+          int iBase = ix * 2;
+          dV = (row_pointers[iy][iBase] + (row_pointers[iy][iBase+1] << 8)) / 65536.;
+        } else
+          dV = 0;
+      } else if (color_type == PNG_COLOR_TYPE_RGB) {
+        if (bit_depth == 8) {
+          int iBase = ix * 3;
+          double dR = row_pointers[iy][iBase] / 255.;
+          double dG = row_pointers[iy][iBase+1] / 255.;
+          double dB = row_pointers[iy][iBase+2] / 255.;
+          dV = colorToGrayscale (dR, dG, dB);
+        } else
+          dV = 0;
+      }
+      v[ix][height-iy-1] = dV;
+    }
+  }
+
+  png_read_end(png_ptr, end_info);
+  png_destroy_read_struct(&png_ptr, &info_ptr, &end_info);
+
+  for (i = 0; i < height; i++)
+    delete row_pointers[i];
+  delete row_pointers;
+
+  fclose (fp);
+  return true;
+}
+#endif
+
+bool
+ImageFile::exportImage (const char* const pszFormat, const char* const pszFilename, int nxcell, int nycell, double densmin, double densmax)
+{
+  int iFormatID = convertExportFormatNameToID (pszFormat);
+
+  if (iFormatID == EXPORT_FORMAT_PGM)
+    return writeImagePGM (pszFilename, nxcell, nycell, densmin, densmax);
+  else if (iFormatID == EXPORT_FORMAT_PGMASCII)
+    return writeImagePGMASCII (pszFilename, nxcell, nycell, densmin, densmax);
+  else if (iFormatID == EXPORT_FORMAT_TEXT)
+    return writeImageText (pszFilename);
+#ifdef HAVE_PNG
+  else if (iFormatID == EXPORT_FORMAT_PNG)
+    return writeImagePNG (pszFilename, 8, nxcell, nycell, densmin, densmax);
+  else if (iFormatID == EXPORT_FORMAT_PNG16)
+    return writeImagePNG (pszFilename, 16, nxcell, nycell, densmin, densmax);
+#endif
+#ifdef HAVE_CTN_DICOM
+  else if (iFormatID == EXPORT_FORMAT_DICOM) {
+    DicomExporter dicomExport (this);
+    bool bSuccess = dicomExport.writeFile (pszFilename);
+    if (! bSuccess)
+      sys_error (ERR_SEVERE, dicomExport.failMessage().c_str());
+    return bSuccess;
+  }
+#endif
+  else if (iFormatID == EXPORT_FORMAT_RAW)
+         return writeImageRaw(pszFilename, nxcell, nycell);
+
+
+  sys_error (ERR_SEVERE, "Invalid format %s [ImageFile::exportImage]", pszFormat);
+  return false;
+}
+
+
+bool
+ImageFile::writeImagePGM (const char* const 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 false;
+
+  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<unsigned int> (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);
+
+  return true;
+}
+
+bool
+ImageFile::writeImagePGMASCII (const char* const 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 false;
+
+  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<unsigned int> (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);
+
+  return true;
+}
+
+bool
+ImageFile::writeImageText (const char* const outfile)
+{
+  FILE *fp;
+  int nx = m_nx;
+  int ny = m_ny;
+  ImageFileArray v = getArray();
+  ImageFileArray vImag = getImaginaryArray();
+
+  if ((fp = fopen (outfile, "w")) == NULL)
+    return false;
+
+  for (int irow = ny - 1; irow >= 0; irow--) {
+    for (int icol = 0; icol < nx; icol++) {
+      if (isComplex()) {
+        if (vImag[icol][irow] >= 0)
+          fprintf (fp, "%.9g+%.9gi ", v[icol][irow], vImag[icol][irow]);
+        else
+          fprintf (fp, "%.9g-%.9gi ", v[icol][irow], -vImag[icol][irow]);
+      } else
+        fprintf (fp, "%12.8g ", v[icol][irow]);
+    }
+    fprintf(fp, "\n");
+  }
+
+  fclose(fp);
+
+  return true;
+}
+
+
+#ifdef HAVE_PNG
+bool
+ImageFile::writeImagePNG (const char* const outfile, int bitdepth, int nxcell, int nycell, double densmin, double densmax)
+{
+  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)];
+
+  FILE *fp = fopen (outfile, "wb");
+  if (! fp)
+    return false;
+
+  png_structp png_ptr = png_create_write_struct (PNG_LIBPNG_VER_STRING, NULL, NULL, NULL);
+  if (! png_ptr)
+    return false;
+
+  png_infop info_ptr = png_create_info_struct (png_ptr);
+  if (! info_ptr) {
+    png_destroy_write_struct (&png_ptr, (png_infopp) NULL);
+    fclose (fp);
+    return false;
+  }
+
+  if (setjmp (png_ptr->jmpbuf)) {
+    png_destroy_write_struct (&png_ptr, &info_ptr);
+    fclose (fp);
+    return false;
+  }
+
+  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_DEFAULT, 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<unsigned int> (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+1] = (outval >> 8) & 0xFF;
+          rowp[rowpos] = (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);
+
+  return true;
+}
+#endif
+
+#ifdef HAVE_GD
+#include "gd.h"
+static const int N_GRAYSCALE=256;
+
+bool
+ImageFile::writeImageGIF (const char* const outfile, int nxcell, int nycell, double densmin, double densmax)
+{
+  int gs_indices[N_GRAYSCALE];
+  int nx = m_nx;
+  int ny = m_ny;
+  ImageFileArray v = getArray();
+
+  unsigned char* rowp = new unsigned char [nx * nxcell];
+
+  gdImagePtr 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]]);
+        }
+      }
+    }
+  }
+
+  FILE *out;
+  if ((out = fopen (outfile,"w")) == NULL) {
+    sys_error(ERR_SEVERE, "Error opening output file %s for writing", outfile);
+    return false;
+  }
+  gdImageGif(gif,out);
+  fclose(out);
+  gdImageDestroy(gif);
+
+  delete rowp;
+
+  return true;
+}
+#endif
+
+bool
+ImageFile::writeImageRaw (const char* const outfile, int nxcell, int nycell)
+{
+  FILE *fp;
+  int nx = m_nx;
+  int ny = m_ny;
+  ImageFileArray v = getArray();
+
+  if ((fp = fopen (outfile, "wb")) == NULL)
+    return false;
+
+  for (int irow = ny - 1; irow >= 0; irow--) {
+    for (int icol = 0; icol < nx; icol++) {
+      float dens = v[icol][irow];
+     fwrite(&dens, sizeof(float), 1, fp);
+    }
+  }
+
+  fclose(fp);
+  return true;
+}
+