r117: *** empty log message ***
[ctsim.git] / libctsim / filter.cpp
index 30d47185e3cd08120a9c66c826d6946afb105f71..c62eb24330d59e0c55645e6918977bc73f5d726a 100644 (file)
@@ -9,7 +9,7 @@
 **  This is part of the CTSim program
 **  Copyright (C) 1983-2000 Kevin Rosenberg
 **
-**  $Id: filter.cpp,v 1.1 2000/06/19 02:59:34 kevin Exp $
+**  $Id: filter.cpp,v 1.3 2000/06/22 10:17:28 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
 
 
 /* NAME
- *   filter_generate                           Generate a filter
+ *   SignalFilter::SignalFilter     Construct a signal
  *
  * SYNOPSIS
- *   f = filter_generate (filt_type, bw, xmin, xmax, n, param, domain, analytic)
- *   double f                          Generated filter vector
- *   int filt_type                     Type of filter wanted
- *   double bw                         Bandwidth of filter
- *   double xmin, xmax                 Filter limits
- *   int n                             Number of points in filter
- *   double param                      General input parameter to filters
- *   int domain                                FREQ or SPATIAL domain wanted
- *   int numint                                Number if intervals for calculating
- *                                     discrete inverse fourier xform
- *                                     for spatial domain filters.  For
- *                                     ANALYTIC solutions, use numint = 0
+ *   f = SignalFilter (filt_type, bw, xmin, xmax, n, param, domain, analytic)
+ *   double f          Generated filter vector
+ *   int filt_type     Type of filter wanted
+ *   double bw         Bandwidth of filter
+ *   double xmin, xmax Filter limits
+ *   int n             Number of points in filter
+ *   double param      General input parameter to filters
+ *   int domain                FREQ or SPATIAL domain wanted
+ *   int numint                Number if intervals for calculating discrete inverse fourier xform
+ *                     for spatial domain filters.  For ANALYTIC solutions, use numint = 0
  */
 
-double *
-filter_generate (const FilterType filt_type, double bw, double xmin, double xmax, int n, double param, const DomainType domain, int numint)
+SignalFilter::SignalFilter (const char* filterName, double bw, double xmin, double xmax, int n, double param, const char* domainName, int numint)
 {
-  double *f = new double [n];
-  double xinc = (xmax - xmin) / (n - 1);
+  m_idFilter = convertFilterNameToID (filterName);
+  m_idDomain = convertDomainNameToID (domainName);
+  init (m_idFilter, bw, xmin, xmax, n, param, m_idDomain, numint);
+}
+
+SignalFilter::SignalFilter (const FilterID filterID, double bw, double xmin, double xmax, int n, double param, const DomainID domainID, int numint)
+{
+  init (filterID, bw, xmin, xmax, n, param, domainID, numint);
+}
+
+void
+SignalFilter::init (const FilterID filterID, double bw, double xmin, double xmax, int n, double param, const DomainID domainID, int numint)
+{
+  m_bw = bw;
+  m_idFilter = filterID;
+  m_idDomain = domainID;
+  if (m_idFilter == FILTER_INVALID || m_idDomain == DOMAIN_INVALID) {
+    m_fail = true;
+    return;
+  }
+  m_nameFilter = convertFilterIDToName (m_idFilter);
+  m_nameDomain = convertDomainIDToName (m_idDomain);
+  m_fail = false;
+  m_nPoints = n;
+  m_xmin = xmin;
+  m_xmax = xmax;
+  m_vecFilter = new double[n];
+
+  double xinc = (m_xmax - m_xmin) / (m_nPoints - 1);
 
-  if (filt_type == FILTER_SHEPP) {
-    double a = 2 * bw;
+  if (m_idFilter == FILTER_SHEPP) {
+    double a = 2 * m_bw;
     double c = - 4. / (a * a);
-    int center = (n - 1) / 2;
+    int center = (m_nPoints - 1) / 2;
     int sidelen = center;
-    f[center] = 4. / (a * a);
-    
+    m_vecFilter[center] = 4. / (a * a);
+
     for (int i = 1; i <= sidelen; i++ )
-      f [center + i] = f [center - i] = c / (4 * (i * i) - 1);
-  } else if (domain == D_FREQ) {
+      m_vecFilter [center + i] = m_vecFilter [center - i] = c / (4 * (i * i) - 1);
+  } else if (m_idDomain == DOMAIN_FREQ) {
     double x;
     int i;
-    for (x = xmin, i = 0; i < n; x += xinc, i++)
-      f[i] = filter_frequency_response (filt_type, x, bw, param);
-  } else if (domain == D_SPATIAL) {
+    for (x = m_xmin, i = 0; i < m_nPoints; x += xinc, i++)
+      m_vecFilter[i] = frequencyResponse (x, param);
+  } else if (m_idDomain == DOMAIN_SPATIAL) {
     double x;
     int i;
-    for (x = xmin, i = 0; i < n; x += xinc, i++)
+    for (x = m_xmin, i = 0; i < m_nPoints; x += xinc, i++)
       if (numint == 0)
-       f[i] = filter_spatial_response_analytic (filt_type, x, bw, param);
+       m_vecFilter[i] = spatialResponseAnalytic (x, param);
       else
-       f[i] = filter_spatial_response_calc (filt_type, x, bw, param, numint);
+       m_vecFilter[i] = spatialResponseCalc (x, param, numint);
   } else {
-    sys_error (ERR_WARNING, "Illegal domain %d [filt_generate]", domain);
-    return (NULL);
+      sys_error (ERR_WARNING, "Illegal domain %d [filt_generate]", m_idDomain);
+      m_fail = true;
   }
-  
-  return (f);
 }
 
+SignalFilter::~SignalFilter (void)
+{
+    delete m_vecFilter;
+}
+
+
+SignalFilter::FilterID
+SignalFilter::convertFilterNameToID (const char *filterName)
+{
+  FilterID filterID;
+
+  if (strcasecmp (filterName, FILTER_BANDLIMIT_STR) == 0)
+    filterID = FILTER_BANDLIMIT;
+  else if (strcasecmp (filterName, FILTER_HAMMING_STR) == 0)
+    filterID = FILTER_G_HAMMING;
+  else if (strcasecmp (filterName, FILTER_SINC_STR) == 0)
+    filterID = FILTER_SINC;
+  else if (strcasecmp (filterName, FILTER_COS_STR) == 0)
+    filterID = FILTER_COSINE;
+  else if (strcasecmp (filterName, FILTER_TRIANGLE_STR) == 0)
+    filterID = FILTER_TRIANGLE;
+  else if (strcasecmp (filterName, FILTER_ABS_BANDLIMIT_STR) == 0)
+    filterID = FILTER_ABS_BANDLIMIT;
+  else if (strcasecmp (filterName, FILTER_ABS_HAMMING_STR) == 0)
+    filterID = FILTER_ABS_G_HAMMING;
+  else if (strcasecmp (filterName, FILTER_ABS_SINC_STR) == 0)
+    filterID = FILTER_ABS_SINC;
+  else if (strcasecmp (filterName, FILTER_ABS_COS_STR) == 0)
+    filterID = FILTER_ABS_COSINE;
+  else if (strcasecmp (filterName, FILTER_SHEPP_STR) == 0)
+    filterID = FILTER_SHEPP;
+  else {
+    sys_error(ERR_WARNING, "Invalid filter type %s\n", filterName);
+    filterID = FILTER_INVALID;
+  }
+
+  return (filterID);
+}
+
+const char *
+SignalFilter::convertFilterIDToName (const FilterID filterID)
+{
+  const char *name = "";
+
+  if (filterID == FILTER_SHEPP)
+    name = FILTER_SHEPP_STR;
+  else if (filterID == FILTER_ABS_COSINE)
+    name = FILTER_ABS_COS_STR;
+  else if (filterID == FILTER_ABS_SINC)
+    name = FILTER_ABS_SINC_STR;
+  else if (filterID == FILTER_ABS_G_HAMMING)
+    name = FILTER_ABS_HAMMING_STR;
+  else if (filterID == FILTER_ABS_BANDLIMIT)
+    name = FILTER_ABS_BANDLIMIT_STR;
+  else if (filterID == FILTER_COSINE)
+    name = FILTER_COS_STR;
+  else if (filterID == FILTER_SINC)
+    name = FILTER_SINC_STR;
+  else if (filterID == FILTER_G_HAMMING)
+    name = FILTER_HAMMING_STR;
+  else if (filterID == FILTER_BANDLIMIT)
+    name = FILTER_BANDLIMIT_STR;
+  else if (filterID == FILTER_TRIANGLE)
+    name = FILTER_TRIANGLE_STR;
+           
+  return (name);
+}
+      
+const SignalFilter::DomainID
+SignalFilter::convertDomainNameToID (const char* const domainName)
+{
+  DomainID dID;
+
+  if (strcasecmp (domainName, DOMAIN_SPATIAL_STR) == 0)
+    dID = DOMAIN_SPATIAL;
+  else if (strcasecmp (domainName, DOMAIN_FREQ_STR) == 0)
+    dID = DOMAIN_FREQ;
+  else
+    dID = DOMAIN_INVALID;
+
+  return (dID);
+}
+
+const char *
+SignalFilter::convertDomainIDToName (const DomainID domain)
+{
+  const char *name = "";
+
+  if (domain == DOMAIN_SPATIAL)
+    return (DOMAIN_SPATIAL_STR);
+  else if (domain == DOMAIN_FREQ)
+    return (DOMAIN_FREQ_STR);
+
+  return (name);
+}
+
+
+double
+SignalFilter::response (const char* filterName, const char* domainName, double bw, double x, double filt_param)
+{
+  double response = 0;
+  FilterID filterID = convertFilterNameToID (filterName);
+  DomainID domainID = convertDomainNameToID (domainName);
+
+  if (domainID == DOMAIN_SPATIAL)
+    response = spatialResponseAnalytic (filterID, bw, x, filt_param);
+  else if (domainID == DOMAIN_FREQ)
+    response = frequencyResponse (filterID, bw, x, filt_param);
+
+  return (response);
+}
 
 /* NAME
  *   filter_spatial_response_calc      Calculate filter by discrete inverse fourier
@@ -89,21 +222,27 @@ filter_generate (const FilterType filt_type, double bw, double xmin, double xmax
  *                                     response
  *
  * SYNOPSIS
- *   y = filter_spatial_response_calc (filt_type, x, bw, param, n)
+ *   y = filter_spatial_response_calc (filt_type, x, m_bw, param, n)
  *   double y                  Filter's response in spatial domain
  *   int filt_type             Type of filter (definitions in ct.h)
  *   double x                  Spatial position to evaluate filter
- *   double bw                 Bandwidth of window
+ *   double m_bw                       Bandwidth of window
  *   double param              General parameter for various filters
  *   int n                     Number of points to calculate integrations
  */
 
 double 
-filter_spatial_response_calc (int filt_type, double x, double bw, double param, int n)
+SignalFilter::spatialResponseCalc (double x, double param, int n) const
+{
+  return (spatialResponseCalc (m_idFilter, m_bw, x, param, n));
+}
+
+double 
+SignalFilter::spatialResponseCalc (FilterID filterID, double bw, double x, double param, int n)
 {
   double zmin, zmax;
 
-  if (filt_type == FILTER_TRIANGLE) {
+  if (filterID == FILTER_TRIANGLE) {
     zmin = 0;
     zmax = bw;
   } else {
@@ -115,7 +254,7 @@ filter_spatial_response_calc (int filt_type, double x, double bw, double param,
   double z = zmin;
   double q [n];
   for (int i = 0; i < n; i++, z += zinc)
-    q[i] = filter_frequency_response (filt_type, z, bw, param) * cos (TWOPI * z * x);
+    q[i] = frequencyResponse (filterID, bw, z, param) * cos (TWOPI * z * x);
   
   double y = 2 * integrateSimpson (zmin, zmax, q, n);
   
@@ -127,21 +266,28 @@ filter_spatial_response_calc (int filt_type, double x, double bw, double param,
  *    filter_frequency_response                        Return filter frequency response
  *
  * SYNOPSIS
- *    h = filter_frequency_response (filt_type, u, bw, param)
+ *    h = filter_frequency_response (filt_type, u, m_bw, param)
  *    double h                 Filters frequency response at u
  *    int filt_type            Type of filter
  *    double u                 Frequency to evaluate filter at
- *    double bw                        Bandwidth of filter
+ *    double m_bw                      Bandwidth of filter
  *    double param             General input parameter for various filters
  */
 
 double 
-filter_frequency_response (int filt_type, double u, double bw, double param)
+SignalFilter::frequencyResponse (double u, double param) const
+{
+  return frequencyResponse (m_idFilter, m_bw, u, param);
+}
+
+
+double 
+SignalFilter::frequencyResponse (FilterID filterID, double bw, double u, double param)
 {
   double q;
   double au = fabs (u);
 
-  switch (filt_type) {
+  switch (filterID) {
   case FILTER_BANDLIMIT:
     if (au >= bw / 2)
       q = 0.;
@@ -192,9 +338,7 @@ filter_frequency_response (int filt_type, double u, double bw, double param)
     break;
   default:
     q = 0;
-    sys_error (ERR_WARNING,
-              "Frequency response for filter %d not implemented [filter_frequency_response]",
-              filt_type);
+    sys_error (ERR_WARNING, "Frequency response for filter %d not implemented [filter_frequency_response]", filterID);
     break;
   }
   return (q);
@@ -208,16 +352,22 @@ filter_frequency_response (int filt_type, double u, double bw, double param)
  *                             response
  *
  * SYNOPSIS
- *   y = filter_spatial_response_analytic (filt_type, x, bw, param)
+ *   y = filter_spatial_response_analytic (filt_type, x, m_bw, param)
  *   double y                  Filter's response in spatial domain
  *   int filt_type             Type of filter (definitions in ct.h)
  *   double x                  Spatial position to evaluate filter
- *   double bw                 Bandwidth of window
+ *   double m_bw                       Bandwidth of window
  *   double param              General parameter for various filters
  */
 
 double 
-filter_spatial_response_analytic (int filt_type, double x, double bw, double param)
+SignalFilter::spatialResponseAnalytic (double x, double param) const
+{
+  return spatialResponseAnalytic (m_idFilter, m_bw, x, param);
+}
+
+double 
+SignalFilter::spatialResponseAnalytic (FilterID filterID, double bw, double x, double param)
 {
   double q, temp;
   double u = TWOPI * x;
@@ -225,7 +375,7 @@ filter_spatial_response_analytic (int filt_type, double x, double bw, double par
   double b = PI / bw;
   double b2 = TWOPI / bw;
 
-  switch (filt_type) {
+  switch (filterID) {
   case FILTER_BANDLIMIT:
     q = bw * sinc(u * w, 1.0);
     break;
@@ -237,8 +387,7 @@ filter_spatial_response_analytic (int filt_type, double x, double bw, double par
     q = sinc(b-u,w) + sinc(b+u,w);
     break;
   case FILTER_G_HAMMING:
-    q = 2 * param * sin(u*w)/u + (1-param) *
-      (sinc(b2-u, w) + sinc(b2+u, w));
+    q = 2 * param * sin(u*w)/u + (1-param) * (sinc(b2-u, w) + sinc(b2+u, w));
     break;
   case FILTER_ABS_BANDLIMIT:
     q = 2 * integral_abscos (u, w);
@@ -264,9 +413,7 @@ filter_spatial_response_analytic (int filt_type, double x, double bw, double par
     break;
   case FILTER_ABS_SINC:
   default:
-    sys_error (ERR_WARNING,
-              "Analytic filter type %d not implemented [filter_spatial_response_analytic]",
-              filt_type);
+    sys_error (ERR_WARNING, "Analytic filter type %d not implemented [filter_spatial_response_analytic]", filterID);
     q = 0;
     break;
   }
@@ -287,12 +434,6 @@ filter_spatial_response_analytic (int filt_type, double x, double bw, double par
  *   v = sin(x * mult) / x;
  */
 
-double 
-sinc (double x, double mult)
-{
-  return (fabs(x) > F_EPSILON ? (sin (x * mult) / x) : 1.0);
-}
-
 
 /* NAME
  *   integral_abscos                   Returns integral of u*cos(u)
@@ -308,7 +449,7 @@ sinc (double x, double mult)
  */
 
 double 
-integral_abscos (double u, double w)
+SignalFilter::integral_abscos (double u, double w)
 {
   if (fabs (u) > F_EPSILON)
     return (cos(u * w) - 1) / (u * u) + w / u * sin (u * w);
@@ -317,3 +458,64 @@ integral_abscos (double u, double w)
 }
 
 
+/* NAME
+ *    convolve                 Discrete convolution of two functions
+ *
+ * SYNOPSIS
+ *    r = convolve (f1, f2, dx, n, np, func_type)
+ *    double r                 Convolved result
+ *    double f1[], f2[]                Functions to be convolved
+ *    double dx                        Difference between successive x values
+ *    int n                    Array index to center convolution about
+ *    int np                   Number of points in f1 array
+ *    int func_type            EVEN or ODD or EVEN_AND_ODD function f2
+ *
+ * NOTES
+ *    f1 is the projection data, its indices range from 0 to np - 1.
+ *    The index for f2, the filter, ranges from -(np-1) to (np-1).
+ *    There are 3 ways to handle the negative vertices of f2:
+ *     1. If we know f2 is an EVEN function, then f2[-n] = f2[n].
+ *        All filters used in reconstruction are even.
+ *      2. If we know f2 is an ODD function, then f2[-n] = -f2[n] 
+ *      3. If f2 is both ODD AND EVEN, then we must store the value of f2
+ *        for negative indices.  Since f2 must range from -(np-1) to (np-1),
+ *        if we add (np - 1) to f2's array index, then f2's index will
+ *        range from 0 to 2 * (np - 1), and the origin, x = 0, will be
+ *        stored at f2[np-1].
+ */
+
+double 
+SignalFilter::convolve (const double func[], const double dx, const int n, const int np) const
+{
+  double sum = 0.0;
+
+#if UNOPTIMIZED_CONVOLUTION
+  for (int i = 0; i < np; i++)
+    sum += func[i] * m_vecFilter[n - i + (np - 1)];
+#else
+  double* f2 = m_vecFilter + n + (np - 1);
+  for (int i = 0; i < np; i++)
+    sum += *func++ * *f2--;
+#endif
+
+  return (sum * dx);
+}
+
+
+double 
+SignalFilter::convolve (const float func[], const double dx, const int n, const int np) const
+{
+  double sum = 0.0;
+
+#if UNOPTIMIZED_CONVOLUTION
+for (int i = 0; i < np; i++)
+  sum += func[i] * m_vecFilter[n - i + (np - 1)];
+#else
+double* f2 = m_vecFilter + n + (np - 1);
+for (int i = 0; i < np; i++)
+  sum += *func++ * *f2--;
+#endif
+
+  return (sum * dx);
+}
+