Warning: file_get_contents(/data/phpspider/zhask/data//catemap/2/image-processing/2.json): failed to open stream: No such file or directory in /data/phpspider/zhask/libs/function.php on line 167

Warning: Invalid argument supplied for foreach() in /data/phpspider/zhask/libs/tag.function.php on line 1116

Notice: Undefined index: in /data/phpspider/zhask/libs/function.php on line 180

Warning: array_chunk() expects parameter 1 to be array, null given in /data/phpspider/zhask/libs/function.php on line 181
C# 带通滤波器组_C#_Image Processing_Filter_Gabor Filter_Bandpass Filter - Fatal编程技术网

C# 带通滤波器组

C# 带通滤波器组,c#,image-processing,filter,gabor-filter,bandpass-filter,C#,Image Processing,Filter,Gabor Filter,Bandpass Filter,我已经实现了一组定向带通滤波器 请参阅“2.1预处理”一节的最后一段 我们选择12个不重叠的过滤器,分析12个不同的方向,相互旋转15° 我有以下问题, 该滤波器组应生成12个滤波图像。但实际上,我只有03个输出,如下面的快照所示 源代码: 这是源代码中最相关的部分 public class KassWitkinFunction { /* * tx = centerX * cos * ty = centerY * sin * *

我已经实现了一组定向带通滤波器

请参阅“2.1预处理”一节的最后一段

我们选择12个不重叠的过滤器,分析12个不同的方向,相互旋转15°

我有以下问题,

该滤波器组应生成12个滤波图像。但实际上,我只有03个输出,如下面的快照所示


源代码:

这是源代码中最相关的部分

public class KassWitkinFunction
{
    /*
     *  tx = centerX * cos 
     *  ty = centerY * sin
     *  
     *  u* =   cos . (u + tx) + sin . (v + ty)
     *  v* = - sin . (u + tx) + cos . (v + ty)
     *  
     */
    //#region MyRegion
    public static double tx(int centerX, double theta)
    {
        double costheta = Math.Cos(theta);
        double txx = centerX * costheta;
        return txx;
    }

    public static double ty(int centerY, double theta)
    {
        double sintheta = Math.Sin(theta);
        double tyy = centerY * sintheta;
        return tyy;
    }

    public static double uStar(double u, double v, int centerX, int centerY, double theta)
    {
        double txx = tx(centerX, theta);
        double tyy = ty(centerY, theta);
        double sintheta = Math.Sin(theta);
        double costheta = Math.Cos(theta);

        double cosThetaUTx = costheta * (u + txx);
        double sinThetaVTy = sintheta * (v + tyy);

        double returns = cosThetaUTx + sinThetaVTy;

        return returns;
    }
    //#endregion

    public static double vStar(double u, double v, int centerX, int centerY, double theta)
    {
        double txx = tx(centerX, theta);
        double tyy = ty(centerY, theta);
        double sintheta = Math.Sin(theta);
        double costheta = Math.Cos(theta);

        double sinThetaUTx = (-1) * sintheta * (u + txx);
        double cosThetaVTy = costheta * (v + tyy);

        double returns = sinThetaUTx + cosThetaVTy;

        return returns;
    }

    public static double ApplyFilterOnOneCoord(double u, double v, double Du, double Dv, int CenterX, int CenterY, double Theta, int N)
    {
        double uStar = KassWitkinFunction.uStar(u, v, CenterX, CenterY, Theta);
        double vStar = KassWitkinFunction.vStar(u, v, CenterX, CenterY, Theta);

        double uStarDu = uStar / Du;
        double vStarDv = vStar / Dv;

        double sqrt = Math.Sqrt(uStarDu + vStarDv);
        double _2n = 2 * N;
        double pow = Math.Pow(sqrt, _2n);
        double div = 1 + 0.414 * pow;

        double returns = 1/div;

        return returns;
    }
}

public class KassWitkinKernel
{
    public readonly int N = 4;
    public int Width { get; set; }
    public int Height { get; set; }
    public double[,] Kernel { get; private set; }
    public double[,] PaddedKernel { get; private set; }
    public double Du { get; set; }
    public double Dv { get; set; }
    public int CenterX { get; set; }
    public int CenterY { get; set; }
    public double ThetaInRadian { get; set; }

    public void SetKernel(double[,] value)
    {
        Kernel = value;
        Width = Kernel.GetLength(0);
        Height = Kernel.GetLength(1);
    }

    public void Pad(int newWidth, int newHeight)
    {
        double[,] temp = (double[,])Kernel.Clone();
        PaddedKernel = ImagePadder.Pad(temp, newWidth, newHeight);
    }

    public Bitmap ToBitmap()
    {
        return ImageDataConverter.ToBitmap(Kernel);
    }

    public Bitmap ToBitmapPadded()
    {
        return ImageDataConverter.ToBitmap(PaddedKernel);
    }

    public Complex[,] ToComplex()
    {
        return ImageDataConverter.ToComplex(Kernel);
    }

    public Complex[,] ToComplexPadded()
    {
        return ImageDataConverter.ToComplex(PaddedKernel);
    }

    public void Compute()
    {
        Kernel = new double[Width, Height];

        for (int i = 0; i < Width; i++)
        {
            for (int j = 0; j < Height; j++)
            {
                Kernel[i, j] = (double)KassWitkinFunction.ApplyFilterOnOneCoord(i, j,
                                                                            Du,
                                                                            Dv,
                                                                            CenterX,
                                                                            CenterY,
                                                                            ThetaInRadian,
                                                                            N);

                //Data[i, j] = r.NextDouble();
            }
        }

        string str = string.Empty;
    }
}

public class KassWitkinBandpassFilter
{
    public Bitmap Apply(Bitmap image, KassWitkinKernel kernel)
    {
        Complex[,] cImagePadded = ImageDataConverter.ToComplex(image);
        Complex[,] cKernelPadded = kernel.ToComplexPadded();
        Complex[,] convolved = Convolution.Convolve(cImagePadded, cKernelPadded);

        return ImageDataConverter.ToBitmap(convolved);
    }
}

public class KassWitkinFilterBank
{
    private List<KassWitkinKernel> Kernels;
    public int NoOfFilters { get; set; }
    public double FilterAngle { get; set; }
    public int WidthWithPadding { get; set; }
    public int HeightWithPadding { get; set; }
    public int KernelDimension { get; set; }

    public KassWitkinFilterBank()
    {}

    public List<Bitmap> Apply(Bitmap bitmap)
    {
        Kernels = new List<KassWitkinKernel>();

        double degrees = FilterAngle;

        KassWitkinKernel kernel;
        for (int i = 0; i < NoOfFilters; i++)
        {
            kernel = new KassWitkinKernel();
            kernel.Width = KernelDimension;
            kernel.Height = KernelDimension;
            kernel.CenterX = (kernel.Width) / 2;
            kernel.CenterY = (kernel.Height) / 2;
            kernel.Du = 2;
            kernel.Dv = 2;
            kernel.ThetaInRadian = Tools.DegreeToRadian(degrees);
            kernel.Compute();
            kernel.Pad(WidthWithPadding, HeightWithPadding);

            Kernels.Add(kernel);

            degrees += degrees;
        }

        List<Bitmap> list = new List<Bitmap>();

        foreach (KassWitkinKernel k in Kernels)
        {
            Bitmap image = (Bitmap)bitmap.Clone();

            Complex[,] cImagePadded = ImageDataConverter.ToComplex(image);
            Complex[,] cKernelPadded = k.ToComplexPadded();
            Complex[,] convolved = Convolution.Convolve(cImagePadded, cKernelPadded);

            Bitmap temp = ImageDataConverter.ToBitmap(convolved);

            list.Add(temp);
        }

        return list;
    }
}
公共类Kasswitkin函数
{
/*
*tx=centerX*cos
*ty=centerY*sin
*  
*u*=cos.(u+tx)+sin.(v+ty)
*v*=-sin.(u+tx)+cos.(v+ty)
*  
*/
//#区域MyRegion
公共静态双发送(int centerX,双θ)
{
双costheta=数学Cos(θ);
双txx=中心x*成本;
返回txx;
}
公共静态双y(int-centerY,双θ)
{
double sintheta=Math.Sin(θ);
双Y=centerY*sintheta;
返回tyy;
}
公共静态双uStar(双u、双v、整数中心X、整数中心Y、双θ)
{
双txx=tx(中心x,θ);
双tyy=ty(中心,θ);
double sintheta=Math.Sin(θ);
双costheta=数学Cos(θ);
双cosThetaUTx=costheta*(u+txx);
双辛特塔夫蒂=辛特塔*(v+tyy);
双倍收益=成本和收益率+sinThetaVTy;
回报;
}
//#端区
公共静态双vStar(双u、双v、int-centerX、int-centerY、双θ)
{
双txx=tx(中心x,θ);
双tyy=ty(中心,θ);
double sintheta=Math.Sin(θ);
双costheta=数学Cos(θ);
双辛特塔X=(-1)*辛特塔*(u+txx);
双cosThetaVTy=costheta*(v+tyy);
双返回=sinThetaUTx+成本平均值;
回报;
}
公共静态双应用程序filteronecord(双u、双v、双Du、双Dv、int CenterX、int CenterY、双θ、int N)
{
双uStar=KassWitkinFunction.uStar(u,v,CenterX,CenterY,Theta);
双vStar=KassWitkinFunction.vStar(u,v,CenterX,CenterY,Theta);
双USTADU=uStar/Du;
双vStarDv=vStar/Dv;
double sqrt=Math.sqrt(uStarDu+vStarDv);
双_2n=2*N;
双功率=数学功率(sqrt,_2n);
双div=1+0.414*pow;
双返回=1/div;
回报;
}
}
公共类KassWitkinKernel
{
公共只读int N=4;
公共整数宽度{get;set;}
公共整数高度{get;set;}
公共双[,]内核{get;私有集;}
public double[,]PaddedKernel{get;private set;}
公共双Du{get;set;}
公共双Dv{get;set;}
公共int CenterX{get;set;}
public int CenterY{get;set;}
公共双泰纳弧度{get;set;}
公共void SetKernel(双[,]值)
{
内核=值;
宽度=内核.GetLength(0);
高度=内核.GetLength(1);
}
公共空白填充(int-newWidth、int-newHeight)
{
double[,]temp=(double[,])Kernel.Clone();
PaddedKernel=ImagePadder.Pad(temp、newWidth、newHeight);
}
公共位图ToBitmap()
{
返回ImageDataConverter.ToBitmap(内核);
}
公共位图ToBitmapPadded()
{
返回ImageDataConverter.ToBitmap(PaddedKernel);
}
公共综合体[,]到综合体()
{
返回ImageDataConverter.ToComplex(内核);
}
公共综合体[,]ToComplexPadded()
{
返回ImageDataConverter.ToComplex(PaddedKernel);
}
公共空间计算()
{
内核=新的双精度[宽度,高度];
对于(int i=0;ipublic static double ApplyFilterOnOneCoord(double u, double v, double Du, double Dv, int CenterX, int CenterY, double Theta, int N)
{
    double uStar = KassWitkinFunction.uStar(u, v, CenterX, CenterY, Theta);
    double vStar = KassWitkinFunction.vStar(u, v, CenterX, CenterY, Theta);
    double uStarDu = uStar / Du;
    double vStarDv = vStar / Dv;
    double sqrt = Math.Sqrt(uStarDu + vStarDv);
    double _2n = 2 * N;
    double pow = Math.Pow(sqrt, _2n);

    if (!double.IsNaN(sqrt) && Math.Abs(pow - Math.Pow(uStarDu + vStarDv, N)) > 1e-7)
    {
         //execution will never reach here!!
    }
    pow = Math.Pow(uStarDu + vStarDv, N);
    double div = 1 + 0.414 * pow;
    double returns = 1 / div;
    return returns;
}
double arg = uStarDu + vStarDv;
double div = 1 + 0.414 * Math.Pow(Math.Abs(arg), N);
public static double uStar(double u, double v, int centerX, int centerY, double theta)
{
    double sintheta = Math.Sin(theta);
    double costheta = Math.Cos(theta);

    return costheta * (u - centerX) + sintheta * (v - centerY);
}

public static double vStar(double u, double v, int centerX, int centerY, double theta)
{
    double sintheta = Math.Sin(theta);
    double costheta = Math.Cos(theta);

    return (-1) * sintheta * (u - centerX) + costheta * (v - centerY);
}

public static double ApplyFilterOnOneCoord(double u, double v, double Du, double Dv, int CenterX, int CenterY, double Theta, int N)
{
    double uStarDu = KassWitkinFunction.uStar(u, v, CenterX, CenterY, Theta) / Du;
    double vStarDv = KassWitkinFunction.vStar(u, v, CenterX, CenterY, Theta) / Dv;

    double arg = uStarDu + vStarDv;
    double div = Math.Sqrt(1 + Math.Pow(arg, 2*N));;

    return 1/div;
}
private Complex[,] cPaddedKernel;

public void Pad(int unpaddedWidth, int unpaddedHeight, int newWidth, int newHeight)
{
  Complex[,] unpaddedKernelFrequencyDomain = ImageDataConverter.ToComplex((double[,])Kernel.Clone());
  FourierTransform ftInverse = new FourierTransform();
  ftInverse.InverseFFT(FourierShifter.RemoveFFTShift(unpaddedKernelFrequencyDomain));

  Complex[,] cKernel = FourierShifter.FFTShift(ftInverse.GrayscaleImageComplex);

  int startPointX = (int)Math.Ceiling((double)(newWidth - unpaddedWidth) / (double)2) - 1;
  int startPointY = (int)Math.Ceiling((double)(newHeight - unpaddedHeight) / (double)2) - 1;
  for (int j = 0; j < newHeight; j++)
  {
    for (int i=0; i<startPointX; i++)
    {
      cKernel[i, j] = 0;
    }
    for (int i = startPointX + unpaddedWidth; i < newWidth; i++)
    {
      cKernel[i, j] = 0;
    }
  }
  for (int i = startPointX; i < startPointX + unpaddedWidth; i++)
  {
    for (int j = 0; j < startPointY; j++)
    {
      cKernel[i, j] = 0;
    }
    for (int j = startPointY + unpaddedHeight; j < newHeight; j++)
    {
      cKernel[i, j] = 0;
    }
  }

  FourierTransform ftForward = new FourierTransform(cKernel); ftForward.ForwardFFT();
  cPaddedKernel = ftForward.FourierImageComplex;
}

public Complex[,] ToComplexPadded()
{
  return cPaddedKernel;
}
public partial class Convolution
{
  public static Complex[,] ConvolveInFrequencyDomain(Complex[,] fftImage, Complex[,] fftKernel)
  {
    Complex[,] convolve = null;

    int imageWidth = fftImage.GetLength(0);
    int imageHeight = fftImage.GetLength(1);

    int maskWidth = fftKernel.GetLength(0);
    int maskHeight = fftKernel.GetLength(1);

    if (imageWidth == maskWidth && imageHeight == maskHeight)
    {
      Complex[,] fftConvolved = new Complex[imageWidth, imageHeight];

      for (int j = 0; j < imageHeight; j++)
      {
        for (int i = 0; i < imageWidth; i++)
        {
          fftConvolved[i, j] = fftImage[i, j] * fftKernel[i, j];
        }
      }

      FourierTransform ftForConv = new FourierTransform();
      ftForConv.InverseFFT(fftConvolved);
      convolve = FourierShifter.FFTShift(ftForConv.GrayscaleImageComplex);

      Rescale(convolve);
    }
    else
    {
      throw new Exception("padding needed");
    }

    return convolve;
  }
}
Bitmap image = (Bitmap)bitmap.Clone();

Complex[,] cImagePadded = ImageDataConverter.ToComplex(image);
FourierTransform ftForImage = new FourierTransform(cImagePadded); ftForImage.ForwardFFT();
Complex[,] fftImage = ftForImage.FourierImageComplex;

foreach (KassWitkinKernel k in Kernels)
{
  Complex[,] cKernelPadded = k.ToComplexPadded();
  Complex[,] convolved = Convolution.ConvolveInFrequencyDomain(fftImage, cKernelPadded);

  Bitmap temp = ImageDataConverter.ToBitmap(convolved);
  list.Add(temp);
}