I have a large array of matricies and need to apply inverse FFT as shown in the attached diagram. I do this by restructuring the data using getindex . After completing the inverse FFT I then recreating the original matrix structure using getindex and reshape. Any suggestions for performance improvements? Its currently way too slow. I have used StaticArrays.jl in the past, but these matrices are too large.
using LinearAlgebra
using FFTW
using BenchmarkTools
function computeBlock(A)
rows = size(A[1],1) #number of rows of A for later use in reshape
B = [zeros(4*length(A)) for _ in 1:length(A[1])] #preallocate B array (including zero pad)
pad = zeros(length(A)+Int(floor(length(A)/2))) #create arrays for zero padding
for i=1:length(A[1]) #add zero padding then shift for ifft
B[i] = [pad;getindex.(A,i);pad]|>fftshift
end
C = real.(ifft.(B)) #take ifft and extract real part
D = [zeros(size(first(A))) for _ in 1:4*length(A)] #preallocate D array
for i = 1:length(C[1]) #reorganize time domain data into stacked matrices
D[i] = reshape(getindex.(C,i),(rows,:))
end
return D
end
dim = 10 #would like this to be as high as 3000
frequencyDomainData = [rand(18,dim) for _ in 1:2^11]
@btime timeDomainData = computeBlock(frequencyDomainData)
As I understand it, you have an LxMxN dataset of Fourier components A, that you want to zero-pad into L’xMxN (with L’=4L) and then ifft into an L’xMxN array C (doing trigonometric interpolation)?
Realize that you are making tons of intermediate copies of your data, which is not very efficient. e.g. B[i] = [pad;getindex.(A,i);pad]|>fftshift allocates at least 2 temporary arrays and discards your previously preallocated B[i] array in favor of the new array on the right-hand side.
I would tend to drop all of the reshaping, and do something like:
use a 3d array rather than an array of arrays
use a precomputed plan with plan_fft, or probably plan_fft! to work in-place
copy into a preallocated zero-padded 3d array C using a single in-place operation on A
use the dims keyword of plan_fft to transform along 1 direction of your 3d array C all in a single call.
I notice that you are doing real(ifft(x)), which is discarding data unless the input frequency-domain data is somewhat special (i.e. the inputs equivalent to an FFT of real data). Either way, you can take advantage of the fact that you only want the real parts of the output by choosing a more specialized transform (e.g. an irfft or an discrete cosine transform via FFTW.r2r.)
Thank you for the response! The only thing I am doing after the ifft is rearranging the data back into an array of matrices. A couple of follow-up questions
I’m struggling to find examples of plan_fft(usage), but if I understand the documentation correctly I can do something like the code below - does this look right (neglecting the zero padding for the moment)?
A = rand(ComplexF64,(4,4,10)) #created a 3D array of complex numbers
p = plan_ifft(A,3) #apply fft to arrays along the 3rd dimension
D = p*A #result is another 3D array
After the ifft, I need to do more operations on each matrix in the stack (transposition, inversion etc.). In the past it has seemed faster to iterate over an array of matrices to avoid slicing. Is there a way to do that on submatrices within the 3D dataset without incurring significant allocations?
The actual complex input data of the of the frequency domain data is such that the imaginary part of the ifft result is effectively zero (i.e. odd symmetry in the imaginary component). I don’t see a plan_irfft() option - are you referring to a different method or package?
The problem your are seeing with slices comes because they allocate. Check out @views. As of 1.5, this should be as fast (or faster) than using an array of arrays.
If your complex input data has conjugate symmetry (real part is symmetric, imaginary part is antisymmetric), then you only need to store half of it. Zero-padding also becomes easier because you only need to zero-pad one side, and there is no point in an fftshift.
FFTW exports a plan_irfft function (or plan_brfft if you don’t need the 1/N normalization); I’m not sure why you don’t see it?
Note that you can use the FFTW.mul! function (equivalent to mul! from the LinearAlgebra package to apply a plan with a precomputed output array.
I need to create the time domain data set at right by applying the inverse FFT to arrays consisting of elements in the same position of each of the matrices in the original array. For example, the red arrow shows the array grouping for the [1,1] matrix position of the frequency domain data set. This operation is performed for each matrix element position.
I prefer to have the data organized in this way for other reasons that call for iterating over each matrix and performing operations such as inversion. I could use the getindex function to group the arrays:
array = getindex.(Matrix,position)
However, it seems like this would be cumbersome since I would then have to reassemble the data set. Does anyone know of a better approach (prioritizing speed)?
If you used a 3d array, you could still iterate over 2d views to do linear algebra on slices.
Otherwise, you don’t have much choice but to make a copy as you transform each slice, e.g. by slicevector .= getindex.(A, index) (using .= to write in-place into a preallocated slicevector, since FFTW requires a strided-vector memory layout.
So here is an example code block that creates a frequency domain array with real part symmetric and imaginary part antisymmetric for frequencies ranging from -3 to 3.
When you say I only need to store half the array, are you saying I can just compute the frequency domain array from 0 to 3 and supply that to the plan_irfft() function? What would the syntax look like for that?
Also, Is the output array likewise only half the original result? If so, how do I get the full set back (the set I would get if I used the full frequency range)?
Finally, how does the FFTW.mul! function you mention work? This was the only thread on Discourse that even mentions this function.
Thanks
using Plots
using FFTW
using SpecialFunctions
using BenchmarkTools
#create the complex frequency domain input array, fd.
N = 2^8 #set to power of 2 for improved ifft efficiency
ω = range(-3,3, length = N) #note: no ω=0 term (intentional) - could set to zero
fd =zeros(Complex{Float64},length(ω))
fd .= -10e-6*exp.(1im .* ω * 5) .* besselk.(0,abs.(ω)*5.0) ./ besselk.(0,abs.(ω)*0.05)
#create ifft plan and execute ifft
p = plan_ifft(fd,1)
td = p*(fd|>fftshift)
#plot output=====================================================
fdplot = plot(ω,real.(fd),label="real",lw=2)
plot!(ω,imag.(fd),label="imag",lw=2)
plot!(title="Frequncy Domain Input Data (pre-shift)")
tdplot = plot(1:N,real.(td|>fftshift),lw=2,label="real",legend=:right)
plot!(1:N,imag.(td|>fftshift),lw=2,label="imag")
plot!(title="Time Domain Output Data (post-shift)")
#imaginary component becomes negligible as # of samples increases
display(fdplot)
display(tdplot)
Plots should look like those below. Notice the imaginary part of the output time domain plot. This is an artifact of the sampling. This becomes negligible at higher sampling rates and I will discard the imaginary content.
The above suggestions were very helpful. The approach of operating on the 3D array and using plan_ifft() sped things up a lot. I now have the following code block:
using LinearAlgebra
using FFTW
using BenchmarkTools
using SpecialFunctions
#function used to populate frequency domain 3D matrix "A"
bessk0(ω) = -10e-6*exp(1im*ω*rand(-1:0.3:1))*besselk(0,abs(ω)*rand(3:0.1:5))/besselk(0,abs(ω)*0.05)
function dim3ifft(ω,N)
dim2 = 3000
@time pad = zeros(18,dim2,3072)
@time A = zeros(Complex{Float64},(18,dim2,length(ω)))
@time for i = 1:18, j = 1:dim2, k = 1:length(ω)
A[i,j,k] = bessk0(ω[k])
end
@time conj!(A)
@time B = reverse(A,dims=3)
@time C = cat(pad,B,A,pad,dims=3)
@time p = plan_ifft(C,3)
@time D = p*C
return D
end
N = 2^11
Ndiv2 = Int(floor(N/2))
ω = range(-3,3, length = N)[1:Ndiv2]
D = dim3ifft(ω,N)
println("done")
When I run the above I get the following times (I’m aware @btime is better, but this is indicative):
The ifft() function takes about 20 seconds. I’m good with that - I’m not sure I can do much better. I tried using irfft() but aliasing in the result was too high unless I used a much larger array. However, there are a couple of other areas where I wonder if I could shave a little time:
The call to bessk0() to populate Array A clearly takes the longest. Any suggestions for how to improve that function call?
Pre-allocating the arrays only takes about half a second, but still longer than I expected. Suggestions here?
Finally, the concatenate operation, cat(), takes longer than I would expect. Suggestions here?
You don’t need to use cat. If you use irfft correctly (so that you don’t need to append the conjugate), just allocate C = zeros(...) and assign a subarray with
C[...] = @view A[...]
Note also that
conj!(A)
B = reverse(A,dims=3)
C = cat(pad,B,A,pad,dims=3)
seems wrong. It doesn’t have conjugate symmetry at all because you conjugate A and then assign it (flipped) to B, rather than conjugating only B or only A. Furthermore, as shown in my example above, you shouldn’t duplicate the DC (0th) or Nyquist (middle) frequencies for the DFT’s conjugate symmetry corresponding to real inputs.
Ok, I think I see what you mean. I also had some issues in my simplified code that were causing problems in the ifft algorithms. Here is what I ended up with:
using FFTW
using SpecialFunctions
using BenchmarkTools
#function use to populate frequency domain array
function bessk0(ω)
if ω == 0
result = -1e-6*log(20.6/5)/log(20/0.05) + 0im
else
result = -1e-6*exp(1im*ω*2)*
((besselk(0,abs(ω)*5) - besselk(0,abs(ω)*20.6))/(besselk(0,abs(ω)*0.05) - besselk(0,abs(ω)*20)))
end
return result
end
function ifftApproach()
N = 2^8
Ndiv2 = Int(floor(N/2))
pad = zeros(N+Ndiv2)
ω = range(-4,4, length = N+1) #n+1 to include the zero term, for use with ifft
fd1 = bessk0.(ω)[1:end-1]
fd1pad = vcat(pad,fd1,pad)|>fftshift
p = plan_ifft(fd1pad,1)
sd1 = p*fd1pad
#sd1 = zeros(ComplexF64,length(fd1pad))
#FFTW.mul!(sd1,p,fd1pad) #negligible reduction using mul!
return sd1
end
function irfftApproach()
N = 2^8
Ndiv2 = Int(floor(N/2))
pad = zeros(N+Ndiv2)
ωh = range(0,4, length = Ndiv2+1) #for use with irfft
fd2 = bessk0.(ωh)
fd2pad = vcat(fd2,pad)
p = plan_irfft(fd2pad,1024,1)
sd2 = p*fd2pad
#sd2 = zeros(1024)
#FFTW.mul!(sd2,p,fd2pad) #negligible reduction using mul!
return sd2
end
@btime sd1 = ifftApproach()
@btime sd2 = irfftApproach()
Nearly cut in half. I tried the mul! function (commented out lines), but saw neglible impact.
The cases produced effectively identical results. Thanks again.