From 22e7990f193401f46a088e9dc99c1d64ca61b252 Mon Sep 17 00:00:00 2001 From: RainerHeintzmann Date: Sat, 4 Mar 2023 16:54:04 +0100 Subject: [PATCH 1/8] completely rewrote the CZT algorithm to be more flexible --- src/czt.jl | 389 +++++++++++++++++++++++++++++++++++++++------------- test/czt.jl | 18 ++- 2 files changed, 309 insertions(+), 98 deletions(-) diff --git a/src/czt.jl b/src/czt.jl index 4475721..73a36ec 100644 --- a/src/czt.jl +++ b/src/czt.jl @@ -1,107 +1,305 @@ -export czt, iczt +using NDTools, IndexFunArrays, FFTW +export czt, iczt, plan_czt, CZTPlan_ND + +""" + get_kernel_1d(RT::Type, N::Integer, M::Integer; a= 1.0, w = cispi(-2/N), extra_phase=0.0, global_phase=0.0) + +calculates the kernel for the Bluestein algorithm. Note that the length depends on the destination size. +Note the the resulting kernel-size is computed based on the minimum required length for the task. +Use `size(result)` to know what to calculate with. The center of the resulting `kernel` is set to the standard +convention position: 0 +The code is based on Rabiner, Schafer & Rader 1969, IEEE Trans. on Audio and Electroacoustics, 17,86-92 + +# Arguments + `RT`: the datatype of the array to transform + `N`: an integer for the length of the source array to transform. + `M`: an integer for the length of the destination array. + `a`: the (complex valued) phasor defining the start of the sampling in the source array + `w`: the (complex valued) phasor defining consecutive sample positions + `extra_phase`: a consecutive phase to apply to the final result, which enables to change the interpretation of the central source positon. + `global_phase`: the start phase of the `extra_phase` to apply. + returns: a tuple of three arrays for the initial multiplication (A*W), the convolution (already fourier-transformed) and the post multiplication. +""" +function get_kernel_1d(RT::Type, N::Integer, M::Integer; a= 1.0, w = cispi(-2/N), extra_phase=0.0, global_phase=0.0) + # intorduce also sscale ?? + # the size needed to avoid wrap + CT = (RT <: Real) ? Complex{RT} : RT + RT = real(CT) + # nowrap_size = N + ceil(N÷2) + # the maximal size where the convolution does not yield zero + # max_size = 2*N-1 + # the minimum size needed for the convolution + # kernel-size for the deconvolution + L = N + M -1 # max(min(max_size, dsize), nowrap_size) + + #Note that the source size ssz is used here + # W of the source for FFTs. + n = (0:N-1) + # pre-calculate the product of a.^(-n) and w to be later multiplied with the input x + # late casting is important, since the rounding errors are overly large if the original calculations are done in Float32. + aw = CT.((a .^ (-n)) .* w .^ ((n .^ 2) ./ 2)) + + conv_kernel = zeros(CT, L) # Array{CT}(undef, L) + m = (0:M-1) + conv_kernel[1:M] .= w .^ (-(m .^ 2) ./ 2) + right_start = L-N+1 + n = (1:N-1) + conv_kernel[L:-1:right_start+1] .= w .^ (.-(n .^ 2) ./ 2) + # calculate W^(k^2/2), we can reuse the conv_kernel definition 1..M and just invert it + # + # The extra_phase accounts for the nominal center position of the source array. Note that this is + # by default selected to be the geometric center and not the Fourier-center result in a real array upon zooming a symmetric even array. + wd = (abs(w)≈1.0) ? CT.(conj.(conv_kernel[1:M]) .* global_phase .* extra_phase.^m) : CT.(inv.(conv_kernel[1:M]) .* global_phase .* extra_phase.^m) + return aw, fft(conv_kernel), wd +end + +# type for planning. The arrays are 1D but oriented +""" + CZTPlan_1D{CT, D} # <: AbstractArray{T,D} + +type used for the onedimensional plan of the chirp Z transformation (CZT). +containing +# Members: + `d`: dimension (only one!) to transform with this plan + `pad_value`: the value to pad wrapped data with (zero is already handled by the `wd` term, if wanted). + `pad_ranges` :: tuple of two ranges of invalid positions, which can be replaced by pad values + `aw`: factor to multiply input with + `fft_fv`: fourier-transform (FFTW) of the convolutio kernel + `wd`: factor to multiply the result of the convolution by + `fftw_plan`: plan for the forward FFTW of the convolution kernel + `ifftw_plan`: plan for the inverse FFTW of the convolution kernel +""" +struct CZTPlan_1D{CT, PT, D} # <: AbstractArray{T,D} + d :: Int + pad_value :: PT + pad_ranges :: NTuple{2,UnitRange{Int64}} + aw :: Array{CT, D} + fft_fv :: Array{CT, D} + wd :: Array{CT, D} + fftw_plan :: FFTW.cFFTWPlan + ifftw_plan :: AbstractFFTs.ScaledPlan + # dimension of this transformation + # as :: Array{T, D} # not needed since it is just the conjugate of ws +end + +""" + CZTPlan_ND{CT, D} # <: AbstractArray{T,D} + +type used for the onedimensional plan of the chirp Z transformation (CZT). +containing +# Members: + `plans`: vector of CZTPlan_1D for each of the directions of the ND array to transform +""" +struct CZTPlan_ND{CT, D} # <: AbstractArray{T,D} + plans :: Vector{CZTPlan_1D{CT,D}} +end + +function get_invalid_ranges(sz, scaled, dsize, dst_center) + start_range = 1:0 + stop_range = 1:0 + if (scaled*sz < dsize) + ceil(Int64, scaled * sz) + valid_start = floor(Int, dst_center - (scaled * sz)/2) + valid_end = ceil(Int, dst_center + (scaled * sz)/2) + start_range = let + if valid_start > 1 + if valid_end <= dsize + 1:valid_start-1 + else + 1+valid_end - dsize:valid_start-1 + end + else + 1:0 + end + end + stop_range = let + if valid_end < dsize + if valid_start < 1 + valid_end+1:dsize+valid_start-1 + else + valid_end+1:dsize + end + else + 1:0 + end + end + end + return (start_range, stop_range) +end + +""" + plan_czt_1d(xin, scaled, d, dsize=size(xin,d); a=nothing, w=nothing, damp=1.0, src_center=(size(xin,d)+1)/2, dst_center=dsize÷2+1, remove_wrap=false, fft_flags=FFTW.ESTIMATE) + +creates a plan for an one-dimensional chirp z-transformation (CZT). The generated plan is then applied via muliplication. For details about the arguments, see czt_1d(). +""" +function plan_czt_1d(xin, scaled, d, dsize=size(xin,d); a=nothing, w=nothing, damp=1.0, src_center=(size(xin,d)+1)/2, dst_center=dsize÷2+1, remove_wrap=false, pad_value=zero(eltype(xin)), fft_flags=FFTW.ESTIMATE) + + a = isnothing(a) ? exp.(-1im*(dst_center-1)*2pi/(scaled*size(xin,d))) : a + w = isnothing(w) ? cispi(-2/(scaled*size(xin,d))) : w + + w = w * damp + extra_phase = exp(1im*2pi*(src_center-1)/(scaled*size(xin,d))) + global_phase = a ^ (src_center-1) + + aw, fft_fv, wd = get_kernel_1d(eltype(xin), size(xin, d), dsize; a=a, w=w, extra_phase=extra_phase, global_phase=global_phase) + + start_range = 1:0 + end_range = 1:0 + if remove_wrap + start_range, stop_range = get_invalid_ranges(size(xin, d), scaled, dsize, dst_center) + wd[start_range] .= zero(eltype(wd)) + wd[stop_range] .= zero(eltype(wd)) + end + + nsz = ntuple((dd) -> (d==dd) ? size(fft_fv, 1) : size(xin, dd), Val(ndims(xin))) + y = Array{eltype(aw), ndims(xin)}(undef, nsz) + + fft_p = plan_fft(y, (d,); flags=fft_flags) + ifft_p = plan_ifft(y, (d,); flags=fft_flags) # inv(fft_p) + + plan = CZTPlan_1D(d, pad_value, (start_range, end_range), reorient(aw, d, Val(ndims(xin))), reorient(fft_fv, d, Val(ndims(xin))), reorient(wd, d, Val(ndims(xin))), fft_p, ifft_p) + return plan +end + +""" + plan_czt(xin, scale, dims, dsize=size(xin); a=nothing, w=nothing, damp=ones(ndims(xin)), src_center=size(xin).÷2 .+1, dst_center=dsize.÷2 .+1, remove_wrap=false, fft_flags=FFTW.ESTIMATE) + +creates a plan for an N-dimensional chirp z-transformation (CZT). The generated plan is then applied via muliplication. For details about the arguments, see czt(). +""" +function plan_czt(xin, scale, dims, dsize=size(xin); a=nothing, w=nothing, damp=ones(ndims(xin)), src_center=size(xin).÷2 .+1, dst_center=dsize.÷2 .+1, remove_wrap=false, fft_flags=FFTW.ESTIMATE) + CT = (eltype(xin) <: Real) ? Complex{eltype(xin)} : eltype(xin) + D = ndims(xin) + plans = [] # Vector{CZT1DPlan{CT,D}} + sz = size(xin) + for d in dims + xin = Array{eltype(xin)}(undef, sz) + p = plan_czt_1d(xin, scale[d], d, dsize[d]; a=a, w=w, damp=damp[d], src_center=src_center[d], dst_center=dst_center[d], remove_wrap=remove_wrap, fft_flags=fft_flags) + sz = ntuple((dd)-> (dd==d) ? dsize[d] : sz[dd], ndims(xin)) + push!(plans, p) + end + return CZTPlan_ND{CT, D}(plans) +end + +function Base.:*(p::CZTPlan_ND, xin::AbstractArray{U,D}; kargs...) where {U,D} # Complex{U} + xout = xin + for pd in p.plans + xout = czt_1d(xout, pd) + end + return xout +end + +# for being called with the less stringent (real) datatype +# function Base.:*(p::CZTPlan_ND, f::AbstractArray{RT,D}; kargs...) where {RT <: Real, D} +# return p * f +# end + """ czt_1d(xin , scaled , d; remove_wrap=false, pad_value=zero(eltype(xin))) -Chirp z transform along a single direction d of an ND array `xin` into the ND array 'xout'. -Note that xin and xout can be the same array for inplace operations. +Chirp z transform along a single direction d of an ND array `xin`. Note that the result type is defined by `eltype(xin)` and not by `scales`. -# References: Rabiner, Schafer, Rader, The Cirp z-Transform Algorithm, IEEE Trans AU 17(1969) p. 86 -This code is loosely based on a 2D Matlab version of the CZT, written by N.G. Worku & H. Gross -with their consent (28. Oct. 2020) to make it openly available. +The code is based on Rabiner, Schafer & Rader 1969, IEEE Trans. on Audio and Electroacoustics, 17,86-92 # Arguments: + `xin`: array to transform + `scaled`: factor to zoom into during the 1-dimensional czt. + `d`: single dimension to transform (as a tuple) -+ `remove_wrap`: if true, the wrapped places will be set to pad_value -+ `pad_value`: the value that the wrap-around will be set to if `remove_wrap` is `true`. - -""" -function czt_1d(xin, scaled, d; remove_wrap=false, pad_value=zero(eltype(xin))) - sz=size(xin) - # returns the real datatype - rtype = real(eltype(xin)) - scaled = rtype(scaled) - dsize = sz[d] - nn = (0:dsize-1) - # 2N +1 new k-space positions - kk = ((-dsize+1):(dsize-1)) - kk2 = rtype.((kk .^ 2) ./ 2) - - # scalar factor - w = cispi(-2/(dsize*scaled)) - # this is needed to center the array according to the center pixel convention - half_pix_shift = (2*(dsize÷2))/dsize - # scalar factor. The correction factor to the right was introduced to be centered correctly on the pixel as ft is. - a = cispi(-1/scaled * half_pix_shift) - ww = w .^ kk2 - aa = a .^ (-nn) - # is a 1d list of factors. This defines the shift in Fourier space (centering of frequencies) - aa .*= ww[dsize .+ nn] - to_fft = NDTools.select_region(1 ./ ww[1:(2*dsize-1)], new_size=(2*dsize,), center=(dsize+1,)) - # return tofft - # is always 1d (small array) - fv = fft(to_fft) - - y = xin .* reorient(aa, d, Val(ndims(xin))) - # twice the size along direction d - nsz = sz .* NDTools.single_dim_size(Val(d),2,Val(length(sz))) - to_fft = NDTools.select_region(y, new_size=nsz, center=nsz.÷2 .+1) - # convolve on a larger grid along one dimension - g = ifft(fft(to_fft, d) .* reorient(fv, d, Val(ndims(xin))), d) - # return g - oldctr = sz[d]÷2 + 1 - newctr = size(g) .÷ 2 .+1 - ctr = ntuple(md -> (md == d) ? newctr[md] + oldctr - 2 : newctr[md], length(newctr)) - - # This is to deal with a strange phase shift appearing for odd-sized arrays - if isodd(dsize) - extra_phase = (2*dsize-2)/(2*dsize) # 5: 12 / 15, 7: 12/14, 9: 16/18, 11: 20/22 - else - extra_phase = 1 - end - # is a 1d list of factors - fak = ww[dsize:(2*dsize-1)] .* cispi.(ramp(rtype,1,dsize, scale=1/scaled * extra_phase)) - # return select_region(g, new_size=sz,center=ctr) - xout = select_region(g, new_size=sz,center=ctr) .* reorient(fak, d, Val(ndims(xin))) - - # this is a fix to deal with the problem that imaginary numbers are appearing for even-sized arrays, caused by the first entry - if iseven(dsize) && (scaled>1.0) - # a `scaled` of one meas this is an ordinary Fourier-transformation without zoom, which needs to keep the highes frequency value - midp = dsize÷2+1 - for o in 1+mod(midp,2):2:dsize - NDTools.slice(xout,d, o) .-= NDTools.slice(xin,d, 1) .* (1im).^mod(o-midp,4) - end - end - if remove_wrap && (scaled < 1.0) - nsz = Tuple(d == nd ? ceil(Int64, scaled * size(xin,d)) : size(xin,nd) for nd=1:ndims(xin)) - return select_region(select_region(xout, new_size=nsz), new_size=size(xout), pad_value=pad_value) - else - return xout ++ `dsize`: size of the destination array ++ `a`: defines the starting phase of the result CZT. This relates to the where the center of the destination array should be. + The default is `nothing` which means it is calculated from the `src_center` argument. ++ `w`: defines the consecutive phases of the result array, i.e. the zoom. It is (default `nothing`) usually automatically calculated from the `scaled` and the `damp` argument. + You only need to state it, if you want to use the low-level interface (e.g. for the Laplace transform). ++ `damp`: a multiplicative factor to apply as a damping coefficient to `w`. ++ `src_center`: position of the nominal central (zero-position) pixel in the source array. By default the Fourier-center `size(src).÷2 .+1` is used. ++ `dst_center`: the center (zero-position) of the destination array. By default the Fourier-center `size(dst).÷2 .+1` is used. ++ `remove_wrap`: if true, the positions that represent a wrap-around will be set to zero ++ `pad_value`: the value to pad wrapped data with. +""" +function czt_1d(xin, scaled, d, dsize=size(xin,d); a=nothing, w=nothing, damp=1.0, src_center=size(xin,d)÷2+1, dst_center=dsize÷2+1, remove_wrap=false, pad_value=zero(eltype(xin)), fft_flags=FFTW.ESTIMATE) + plan = plan_czt_1d(xin, scaled, d, dsize; a=a, w=w, damp, src_center=src_center, dst_center=dst_center, remove_wrap=remove_wrap, pad_value=pad_value, fft_flags=fft_flags); + return plan * xin +end + +function Base.:*(p::CZTPlan_1D, xin::AbstractArray{U,D}; kargs...) where {U,D} # Complex{U} + return czt_1d(xin, p) +end + +# for being called with the less stringent (real) datatype +# function Base.:*(p::CZTPlan_1D, f::AbstractArray{RT,D}; kargs...) where {RT <: Real, D} +# return p * f +# end + + +""" + czt_1d(xin , plan::CZTPlan_1D) + +Chirp z transform along a single direction d of an ND array `xin`. +Note that the result type is defined by `eltype(xin)` and not by `scales`. +The plan can also be applied via multiplication with `xin`. + +The code is based on Rabiner, Schafer & Rader 1969, IEEE Trans. on Audio and Electroacoustics, 17,86-92 + +# Arguments + `plan`: A plan created via plan_czt_1d() +""" +function czt_1d(xin, plan::CZTPlan_1D) + # destination position + # cispi(-1/scaled * half_pix_shift) + # + # The extra_phase accounts for the nominal center position of the source array. + # Note that the default for src_center is the Fourier-center + # which (intentionally) leads to non-real results for even-sized arrays at non-unit zoom + + L = size(plan.fft_fv, plan.d) + nsz = ntuple((dd) -> (dd==plan.d) ? L : size(xin, dd), Val(ndims(xin))) + # append zeros + y = zeros(eltype(plan.aw), nsz) + myrange = ntuple((dd) -> (1:size(xin,dd)), Val(ndims(xin))) + y[myrange...] = xin .* plan.aw + # corner = ntuple((x)->1, Val(ndims(xin))) + # select_region(xin .* plan.aw, new_size=nsz, center=corner, dst_center=corner) + + # g = ifft(fft(y, d) .* plan.fft_fv, d) + g = plan.ifftw_plan * (plan.fftw_plan * y .* plan.fft_fv) + # dsz = ntuple((dd) -> (d==dd) ? dsize : size(xin), Val(ndims(xin))) + # return only the wanted (valid) part + myrange = ntuple((dd) -> (dd==plan.d) ? (1:size(plan.wd,plan.d)) : (1:size(xin, dd)), Val(ndims(xin))) + res = g[myrange...] .* plan.wd + # pad_value=0 means that it is either already handled by plan.wd or no padding is wanted. + if plan.pad_value != 0 + myrange = ntuple((dd) -> (dd==plan.d) ? plan.pad_ranges[1] : Colon(), Val(ndims(xin))) + res[myrange...] .= plan.pad_value + myrange = ntuple((dd) -> (dd==plan.d) ? plan.pad_ranges[2] : Colon(), Val(ndims(xin))) + res[myrange...] .= plan.pad_value end - # xout .= g[dsize:(2*dsize-1)] .* reorient(fak, d, Val(ndims(xin))) + return res end """ - czt(xin , scale, dims=1:length(size(xin)), remove_wrap=false) + czt(xin, scale, dims=1:ndims(xin), dsize=size(xin,d); a=nothing, w=nothing, damp=ones(ndims(xin)), src_center=size(xin,d)÷2+1, dst_center=dsize÷2+1, remove_wrap=false, fft_flags=FFTW.ESTIMATE) Chirp z transform of the ND array `xin` -This code is based on a 2D Matlab version of the CZT, written by H. Gross. The tuple `scale` defines the zoom factors in the Fourier domain. Each has to be bigger than one. # See also: `iczt`, `czt_1d` - -# References: Rabiner, Schafer, Rader, The Cirp z-Transform Algorithm, IEEE Trans AU 17(1969) p. 86 +The code is based on Rabiner, Schafer & Rader 1969, IEEE Trans. on Audio and Electroacoustics, 17,86-92 # Arguments: + `xin`: array to transform + `scale`: a tuple of factors (one for each dimension) to zoom into during the czt. Note that a factor of nothing (or 1.0) needs to be provided, if a dimension is not transformed. + `dims`: a tuple of dimensions over which to apply the czt. -+ `remove_wrap`: if true, the wrapped places will be set to zero. - Note that the `pad_value` argument is only allowed for czt_1d to not cause confusion. ++ `dsize`: a tuple specifying the destination size ++ `a`: defines the starting phase of the result CZT. This relates to the where the center of the destination array should be. + The default is `nothing` which means it is calculated from the `src_center` argument. ++ `w`: defines the consecutive phases of the result array, i.e. the zoom. It is (default `nothing`) usually automatically calculated from the `scaled` and the `damp` argument. + You only need to state it, if you want to use the low-level interface (e.g. for the Laplace transform). ++ `damp`: a multiplicative factor to apply as a damping coefficient to `w`. ++ `src_center`: position of the nominal central (zero-position) pixel in the source array. By default the Fourier-center `size(src).÷2 .+1` is used. ++ `dst_center`: the center (zero-position) of the destination array. By default the Fourier-center `size(dst).÷2 .+1` is used. ++ `remove_wrap`: if true, the positions that represent a wrap-around will be set to zero # Example: @@ -139,8 +337,8 @@ julia> zoomed = real.(ift(xft)) 0.0239759 -0.028264 0.0541186 -0.0116475 -0.261294 0.312719 -0.261294 -0.0116475 0.0541186 -0.028264 ``` """ -function czt(xin::AbstractArray{T,N}, scale, dims=1:length(size(xin)); - remove_wrap=false)::AbstractArray{complex(T),N} where {T,N} +function czt(xin::AbstractArray{T,N}, scale, dims=1:ndims(xin), dsize=size(xin); + a=nothing, w=nothing, damp=ones(ndims(xin)), src_center=size(xin).÷2 .+1, dst_center=dsize.÷2 .+1, remove_wrap=false, pad_value=zero(eltype(xin)), fft_flags=FFTW.ESTIMATE)::AbstractArray{complex(T),N} where {T,N} xout = xin if length(scale) != ndims(xin) error("Every of the $(ndims(xin)) dimension needs exactly one corresponding scale (zoom) factor, which should be equal to 1.0 for dimensions not contained in the dims argument.") @@ -151,27 +349,32 @@ function czt(xin::AbstractArray{T,N}, scale, dims=1:length(size(xin)); end end for d in dims - xout = czt_1d(xout, scale[d], d; remove_wrap=remove_wrap) + xout = czt_1d(xout, scale[d], d, dsize[d]; a=a, w=w, damp=damp[d], src_center=src_center[d], dst_center=dst_center[d], remove_wrap=remove_wrap, pad_value=pad_value, fft_flags=fft_flags) end return xout end """ - iczt(xin , scale, dims=1:length(size(xin)); remove_wrap=false) + iczt(xin ,scale, dims=1:length(size(xin)), dsize=size(xin,d); a=nothing, w=nothing, damp=1.0, src_center=size(xin,d)÷2+1, dst_center=dsize÷2+1, remove_wrap=false, fft_flags=FFTW.ESTIMATE) Inverse chirp z transform of the ND array `xin` -This code is based on a 2D Matlab version of the CZT, written by H. Gross. -The tuple `scale` defines the zoom factors in the Fourier domain. Each has to be bigger than one. - -# References: Rabiner, Schafer, Rader, The Cirp z-Transform Algorithm, IEEE Trans AU 17(1969) p. 86 +The tuple `scale` defines the zoom factors in the Fourier domain. Each has to be bigger than one. +The code is based on Rabiner, Schafer & Rader 1969, IEEE Trans. on Audio and Electroacoustics, 17,86-92 # Arguments: + `xin`: array to transform -+ `scale`: a tuple of factors (one for each dimension) of the the inverse czt. - Note that a factor of nothing (or 1.0) needs to be provided, if a dimension is not transformed. -+ `dims`: a tuple of dimensions over which to apply the inverse czt. -+ `remove_wrap`: if true, the wrapped places will be set to zero. - Note that the `pad_value` argument is only allowed for 1d czts to not cause confusion. ++ `scaled`: factor to zoom into during the 1-dimensional czt. ++ `d`: single dimension to transform (as a tuple) ++ `dsize`: size of the destination array ++ `a`: defines the starting phase of the result CZT. This relates to the where the center of the destination array should be. + The default is `nothing` which means it is calculated from the `src_center` argument. ++ `w`: defines the consecutive phases of the result array, i.e. the zoom. It is (default `nothing`) usually automatically calculated from the `scaled` and the `damp` argument. + You only need to state it, if you want to use the low-level interface (e.g. for the Laplace transform). ++ `damp`: a multiplicative factor to apply as a damping coefficient to `w`. ++ `src_center`: position of the nominal central (zero-position) pixel in the source array. By default the Fourier-center `size(src).÷2 .+1` is used. ++ `dst_center`: the center (zero-position) of the destination array. By default the Fourier-center `size(dst).÷2 .+1` is used. ++ `remove_wrap`: if true, the positions that represent a wrap-around will be set to zero ++ `pad_value`: the value to pad wrapped data with. See also: `czt`, `czt_1d` @@ -212,6 +415,6 @@ julia> iczt(xft,(1.2,1.3)) -0.0965531+0.0404296im -0.159713+0.0637132im 0.48095+0.0775406im 0.67753-0.263814im 0.77553-0.121603im 0.660335-0.00736904im 0.495205-0.135059im -0.163859+0.125535im ``` """ -function iczt( xin , scale, dims=1:length(size(xin)); remove_wrap=false) - conj(czt(conj(xin), scale, dims; remove_wrap=remove_wrap)) / prod(size(xin)) +function iczt(xin ,scale, dims=1:ndims(xin), dsize=size(xin); a=nothing, w=nothing, damp=ones(ndims(xin)), src_center=size(xin).÷2 .+1, dst_center=dsize.÷2 .+1, remove_wrap=false, pad_value=zero(eltype(xin)), fft_flags=FFTW.ESTIMATE) + conj(czt(conj(xin), scale, dims, dsize; a=a, w=w, damp=damp, src_center=src_center, dst_center=dst_center, remove_wrap=remove_wrap, pad_value=pad_value*prod(size(xin)), fft_flags=fft_flags)) / prod(size(xin)) end diff --git a/test/czt.jl b/test/czt.jl index f5173f8..66458d0 100644 --- a/test/czt.jl +++ b/test/czt.jl @@ -7,17 +7,25 @@ using NDTools # this is needed for the select_region! function below. @test eltype(czt(x, (2f0,2f0,2f0))) == ComplexF32 y = randn(ComplexF32, (5,6)) zoom = (1.0,1.0,1.0) - @test ≈(czt(x, zoom), ft(x),rtol=1e-4) - @test ≈(czt(y, (1.0,1.0)), ft(y),rtol=1e-5) - @test ≈(iczt(czt(y, (1.0,1.0)), (1.0,1.0)), y, rtol=1e-5) + @test ≈(czt(x, zoom), ft(x), rtol=1e-4) + @test ≈(czt(y, (1.0,1.0)), ft(y), rtol=1e-5) + @test ≈(iczt(czt(y, (1.0,1.0)), (1.0,1.0)), y, rtol=1e-5) zoom = (2.0,2.0) - @test ≈(czt(y,zoom), select_region(upsample2(ft(y), fix_center=true),new_size=size(y)), rtol=1e-5) + @test sum(abs.(imag(czt(ones(5,6),zoom, src_center=((5,6).+1)./2)))) < 1e-8 + + # for even sizes the czt is not the same as the ft and upsample operation. But should it be or not? + # @test ≈(real.(czt(y,zoom)), select_region(upsample2(ft(y), fix_center=true), new_size=size(y)), rtol=1e-5) + + # for uneven sizes this works: + @test ≈(czt(y[1:5,1:5],zoom, (1,2), (10,10)), upsample2(ft(y[1:5,1:5]), fix_center=true), rtol=1e-5) # zoom smaller 1.0 causes wrap around: zoom = (0.5,2.0) @test abs(czt(y,zoom)[1,1]) > 1e-5 - zoom = (0.5,2.0) + zoom = (2.0, 0.5) # check if the remove_wrap works @test abs(czt(y,zoom; remove_wrap=true)[1,1]) == 0.0 @test abs(iczt(y,zoom; remove_wrap=true)[1,1]) == 0.0 + @test abs(czt(y,zoom; pad_value=0.2, remove_wrap=true)[1,1]) == 0.2f0 + @test abs(iczt(y,zoom; pad_value=0.5f0, remove_wrap=true)[1,1]) == 0.5f0 end end From 2e257dcc99c3534285968fbc9277a2ce4fd381f4 Mon Sep 17 00:00:00 2001 From: RainerHeintzmann Date: Sat, 4 Mar 2023 17:05:45 +0100 Subject: [PATCH 2/8] bug fix in working with plans --- src/czt.jl | 10 +++++----- test/czt.jl | 2 ++ 2 files changed, 7 insertions(+), 5 deletions(-) diff --git a/src/czt.jl b/src/czt.jl index 73a36ec..4dfe250 100644 --- a/src/czt.jl +++ b/src/czt.jl @@ -90,8 +90,8 @@ containing # Members: `plans`: vector of CZTPlan_1D for each of the directions of the ND array to transform """ -struct CZTPlan_ND{CT, D} # <: AbstractArray{T,D} - plans :: Vector{CZTPlan_1D{CT,D}} +struct CZTPlan_ND{CT, PT, D} # <: AbstractArray{T,D} + plans :: Vector{CZTPlan_1D{CT,PT, D}} end function get_invalid_ranges(sz, scaled, dsize, dst_center) @@ -166,18 +166,18 @@ end creates a plan for an N-dimensional chirp z-transformation (CZT). The generated plan is then applied via muliplication. For details about the arguments, see czt(). """ -function plan_czt(xin, scale, dims, dsize=size(xin); a=nothing, w=nothing, damp=ones(ndims(xin)), src_center=size(xin).÷2 .+1, dst_center=dsize.÷2 .+1, remove_wrap=false, fft_flags=FFTW.ESTIMATE) +function plan_czt(xin, scale, dims, dsize=size(xin); a=nothing, w=nothing, damp=ones(ndims(xin)), src_center=size(xin).÷2 .+1, dst_center=dsize.÷2 .+1, remove_wrap=false, pad_value=zero(eltype(xin)), fft_flags=FFTW.ESTIMATE) CT = (eltype(xin) <: Real) ? Complex{eltype(xin)} : eltype(xin) D = ndims(xin) plans = [] # Vector{CZT1DPlan{CT,D}} sz = size(xin) for d in dims xin = Array{eltype(xin)}(undef, sz) - p = plan_czt_1d(xin, scale[d], d, dsize[d]; a=a, w=w, damp=damp[d], src_center=src_center[d], dst_center=dst_center[d], remove_wrap=remove_wrap, fft_flags=fft_flags) + p = plan_czt_1d(xin, scale[d], d, dsize[d]; a=a, w=w, damp=damp[d], src_center=src_center[d], dst_center=dst_center[d], remove_wrap=remove_wrap, pad_value=pad_value, fft_flags=fft_flags) sz = ntuple((dd)-> (dd==d) ? dsize[d] : sz[dd], ndims(xin)) push!(plans, p) end - return CZTPlan_ND{CT, D}(plans) + return CZTPlan_ND{CT, typeof(pad_value),D}(plans) end function Base.:*(p::CZTPlan_ND, xin::AbstractArray{U,D}; kargs...) where {U,D} # Complex{U} diff --git a/test/czt.jl b/test/czt.jl index 66458d0..97d2ac1 100644 --- a/test/czt.jl +++ b/test/czt.jl @@ -18,6 +18,8 @@ using NDTools # this is needed for the select_region! function below. # for uneven sizes this works: @test ≈(czt(y[1:5,1:5],zoom, (1,2), (10,10)), upsample2(ft(y[1:5,1:5]), fix_center=true), rtol=1e-5) + p_czt = plan_czt(y, zoom, (1,2), (11,12)) + @test ≈(p_czt * y, czt(y, zoom, (1,2), (11,12))) # zoom smaller 1.0 causes wrap around: zoom = (0.5,2.0) @test abs(czt(y,zoom)[1,1]) > 1e-5 From f30518a6651b2b3c9fc1b876c1a55d6c7d369c86 Mon Sep 17 00:00:00 2001 From: RainerHeintzmann Date: Sat, 4 Mar 2023 17:49:27 +0100 Subject: [PATCH 3/8] bug fix in iczt scaling with specified dimensions --- src/czt.jl | 3 ++- test/czt.jl | 8 +++++++- 2 files changed, 9 insertions(+), 2 deletions(-) diff --git a/src/czt.jl b/src/czt.jl index 4dfe250..03cfb2e 100644 --- a/src/czt.jl +++ b/src/czt.jl @@ -416,5 +416,6 @@ julia> iczt(xft,(1.2,1.3)) ``` """ function iczt(xin ,scale, dims=1:ndims(xin), dsize=size(xin); a=nothing, w=nothing, damp=ones(ndims(xin)), src_center=size(xin).÷2 .+1, dst_center=dsize.÷2 .+1, remove_wrap=false, pad_value=zero(eltype(xin)), fft_flags=FFTW.ESTIMATE) - conj(czt(conj(xin), scale, dims, dsize; a=a, w=w, damp=damp, src_center=src_center, dst_center=dst_center, remove_wrap=remove_wrap, pad_value=pad_value*prod(size(xin)), fft_flags=fft_flags)) / prod(size(xin)) + factor = prod(size(xin)[[dims...]]) + conj(czt(conj(xin), scale, dims, dsize; a=a, w=w, damp=damp, src_center=src_center, dst_center=dst_center, remove_wrap=remove_wrap, pad_value=pad_value*factor, fft_flags=fft_flags)) / factor end diff --git a/test/czt.jl b/test/czt.jl index 97d2ac1..9836d07 100644 --- a/test/czt.jl +++ b/test/czt.jl @@ -5,16 +5,22 @@ using NDTools # this is needed for the select_region! function below. x = randn(ComplexF32, (5,6,7)) @test eltype(czt(x, (2.0,2.0,2.0))) == ComplexF32 @test eltype(czt(x, (2f0,2f0,2f0))) == ComplexF32 + @test ≈(czt(x, (1.0,1.0,1.0), (1,3)), ft(x, (1,3)), rtol=1e-5) + @test ≈(czt(x, (1.0,1.0,1.0), (1,3), src_center=(1,1,1), dst_center=(1,1,1)), fft(x, (1,3)), rtol=1e-5) + @test ≈(iczt(x, (1.0,1.0,1.0), (1,3), src_center=(1,1,1), dst_center=(1,1,1)), ifft(x, (1,3)), rtol=1e-5) + y = randn(ComplexF32, (5,6)) zoom = (1.0,1.0,1.0) @test ≈(czt(x, zoom), ft(x), rtol=1e-4) @test ≈(czt(y, (1.0,1.0)), ft(y), rtol=1e-5) + @test ≈(iczt(czt(y, (1.0,1.0)), (1.0,1.0)), y, rtol=1e-5) zoom = (2.0,2.0) @test sum(abs.(imag(czt(ones(5,6),zoom, src_center=((5,6).+1)./2)))) < 1e-8 # for even sizes the czt is not the same as the ft and upsample operation. But should it be or not? - # @test ≈(real.(czt(y,zoom)), select_region(upsample2(ft(y), fix_center=true), new_size=size(y)), rtol=1e-5) + # @test ≈(czt(y,zoom), select_region(upsample2(ft(y), fix_center=true), new_size=size(y)), rtol=1e-5) + # @test ≈(czt(y,zoom, src_center=(size(y).+1)./2), select_region(upsample2(ft(y), fix_center=true), new_size=size(y)), rtol=1e-5) # for uneven sizes this works: @test ≈(czt(y[1:5,1:5],zoom, (1,2), (10,10)), upsample2(ft(y[1:5,1:5]), fix_center=true), rtol=1e-5) From f1d558d4fba5795ecc02658317a385cc9a04e7db Mon Sep 17 00:00:00 2001 From: RainerHeintzmann Date: Sat, 4 Mar 2023 18:08:29 +0100 Subject: [PATCH 4/8] added docstrings --- docs/src/czt.md | 9 ++++++--- 1 file changed, 6 insertions(+), 3 deletions(-) diff --git a/docs/src/czt.md b/docs/src/czt.md index aaa2b59..f17a594 100644 --- a/docs/src/czt.md +++ b/docs/src/czt.md @@ -1,11 +1,14 @@ # CZTs Chirp Z Transformations: Allows Fourier-transformation and at the same time zooming into the result, which is why it is also called the Zoomed-FFT algorithm. -The algorithm is loosely based on a publication [Rabiner, Schafer, Rader, The Cirp z-Transform Algorithm, IEEE Trans AU 17(1969) p. 86] and a 2D Matlab Version written by N.G. Worku & H. Gross, with their consent (28. Oct. 2020) to make it openly available. It currently needs three FFTs to perform its work. -As one of these FFTs only depends on the datasize and zoom parameters, it can be moved to a plan in future implementations. - +The algorithm is loosely based on a publication [Rabiner, Schafer, Rader, The Chirp z-Transform Algorithm, IEEE Trans AU 17(1969) p. 86]. It needs three FFTs to perform its work but one can be precalculated by using `plan_czt`. +Variable zooms, transform dimensions, array center positions as well as output sizes are supported along wiht a low-level interface by specifingy `a` and `w`. ```@docs FourierTools.czt +FourierTools.plan_czt FourierTools.iczt FourierTools.czt_1d +FourierTools.plan_czt_1d +FourierTools.CZTPlan_1D +FourierTools.CZTPlan_ND ``` From 21dec9242d588a3c29104857dac802cdf95c41de Mon Sep 17 00:00:00 2001 From: RainerHeintzmann Date: Sat, 11 Mar 2023 14:39:14 +0100 Subject: [PATCH 5/8] a few minor fixes --- src/czt.jl | 84 ++++++++++++++++++++++++++++++++++-------------------- 1 file changed, 53 insertions(+), 31 deletions(-) diff --git a/src/czt.jl b/src/czt.jl index 03cfb2e..5874ee7 100644 --- a/src/czt.jl +++ b/src/czt.jl @@ -1,5 +1,4 @@ -using NDTools, IndexFunArrays, FFTW -export czt, iczt, plan_czt, CZTPlan_ND +export czt, iczt, plan_czt """ get_kernel_1d(RT::Type, N::Integer, M::Integer; a= 1.0, w = cispi(-2/N), extra_phase=0.0, global_phase=0.0) @@ -16,9 +15,11 @@ The code is based on Rabiner, Schafer & Rader 1969, IEEE Trans. on Audio and El `M`: an integer for the length of the destination array. `a`: the (complex valued) phasor defining the start of the sampling in the source array `w`: the (complex valued) phasor defining consecutive sample positions - `extra_phase`: a consecutive phase to apply to the final result, which enables to change the interpretation of the central source positon. + `extra_phase`: a phase ramp to apply to the final result, which enables to change the interpretation + of the central source positon. `global_phase`: the start phase of the `extra_phase` to apply. - returns: a tuple of three arrays for the initial multiplication (A*W), the convolution (already fourier-transformed) and the post multiplication. + returns: a tuple of three arrays for the initial multiplication (A*W), the convolution + (already fourier-transformed) and the post multiplication. """ function get_kernel_1d(RT::Type, N::Integer, M::Integer; a= 1.0, w = cispi(-2/N), extra_phase=0.0, global_phase=0.0) # intorduce also sscale ?? @@ -48,7 +49,10 @@ function get_kernel_1d(RT::Type, N::Integer, M::Integer; a= 1.0, w = cispi(-2/N) # calculate W^(k^2/2), we can reuse the conv_kernel definition 1..M and just invert it # # The extra_phase accounts for the nominal center position of the source array. Note that this is - # by default selected to be the geometric center and not the Fourier-center result in a real array upon zooming a symmetric even array. + # by default selected to be the geometric center and not the Fourier-center result in a + # real array upon zooming a symmetric even array. + # Note that the casting is intentionally performed after the calculation, as for many cases + # the calculation precision in the coarse datatype is insufficient. wd = (abs(w)≈1.0) ? CT.(conj.(conv_kernel[1:M]) .* global_phase .* extra_phase.^m) : CT.(inv.(conv_kernel[1:M]) .* global_phase .* extra_phase.^m) return aw, fft(conv_kernel), wd end @@ -128,18 +132,21 @@ function get_invalid_ranges(sz, scaled, dsize, dst_center) end """ - plan_czt_1d(xin, scaled, d, dsize=size(xin,d); a=nothing, w=nothing, damp=1.0, src_center=(size(xin,d)+1)/2, dst_center=dsize÷2+1, remove_wrap=false, fft_flags=FFTW.ESTIMATE) + plan_czt_1d(xin, scaled, d, dsize=size(xin,d); a=nothing, w=nothing, damp=1.0, src_center=(size(xin,d)+1)/2, + dst_center=dsize÷2+1, remove_wrap=false, fft_flags=FFTW.ESTIMATE) -creates a plan for an one-dimensional chirp z-transformation (CZT). The generated plan is then applied via muliplication. For details about the arguments, see czt_1d(). +creates a plan for an one-dimensional chirp z-transformation (CZT). The generated plan is then applied via +muliplication. For details about the arguments, see `czt_1d()`. """ -function plan_czt_1d(xin, scaled, d, dsize=size(xin,d); a=nothing, w=nothing, damp=1.0, src_center=(size(xin,d)+1)/2, dst_center=dsize÷2+1, remove_wrap=false, pad_value=zero(eltype(xin)), fft_flags=FFTW.ESTIMATE) +function plan_czt_1d(xin, scaled, d, dsize=size(xin,d); a=nothing, w=nothing, extra_phase=nothing, global_phase=nothing, damp=1.0, src_center=(size(xin,d)+1)/2, + dst_center=dsize÷2+1, remove_wrap=false, pad_value=zero(eltype(xin)), fft_flags=FFTW.ESTIMATE) - a = isnothing(a) ? exp.(-1im*(dst_center-1)*2pi/(scaled*size(xin,d))) : a + a = isnothing(a) ? exp(-1im*(dst_center-1)*2pi/(scaled*size(xin,d))) : a w = isnothing(w) ? cispi(-2/(scaled*size(xin,d))) : w w = w * damp - extra_phase = exp(1im*2pi*(src_center-1)/(scaled*size(xin,d))) - global_phase = a ^ (src_center-1) + extra_phase = isnothing(extra_phase) ? exp(1im*2pi*(src_center-1)/(scaled*size(xin,d))) : extra_phase + global_phase = isnothing(global_phase) ? a ^ (src_center-1) : global_phase aw, fft_fv, wd = get_kernel_1d(eltype(xin), size(xin, d), dsize; a=a, w=w, extra_phase=extra_phase, global_phase=global_phase) @@ -162,9 +169,11 @@ function plan_czt_1d(xin, scaled, d, dsize=size(xin,d); a=nothing, w=nothing, da end """ - plan_czt(xin, scale, dims, dsize=size(xin); a=nothing, w=nothing, damp=ones(ndims(xin)), src_center=size(xin).÷2 .+1, dst_center=dsize.÷2 .+1, remove_wrap=false, fft_flags=FFTW.ESTIMATE) + plan_czt(xin, scale, dims, dsize=size(xin); a=nothing, w=nothing, damp=ones(ndims(xin)), + src_center=size(xin).÷2 .+1, dst_center=dsize.÷2 .+1, remove_wrap=false, fft_flags=FFTW.ESTIMATE) -creates a plan for an N-dimensional chirp z-transformation (CZT). The generated plan is then applied via muliplication. For details about the arguments, see czt(). +creates a plan for an N-dimensional chirp z-transformation (CZT). The generated plan is then applied via +muliplication. For details about the arguments, see `czt()`. """ function plan_czt(xin, scale, dims, dsize=size(xin); a=nothing, w=nothing, damp=ones(ndims(xin)), src_center=size(xin).÷2 .+1, dst_center=dsize.÷2 .+1, remove_wrap=false, pad_value=zero(eltype(xin)), fft_flags=FFTW.ESTIMATE) CT = (eltype(xin) <: Real) ? Complex{eltype(xin)} : eltype(xin) @@ -207,18 +216,23 @@ The code is based on Rabiner, Schafer & Rader 1969, IEEE Trans. on Audio and El + `scaled`: factor to zoom into during the 1-dimensional czt. + `d`: single dimension to transform (as a tuple) + `dsize`: size of the destination array -+ `a`: defines the starting phase of the result CZT. This relates to the where the center of the destination array should be. - The default is `nothing` which means it is calculated from the `src_center` argument. ++ `a`: defines the starting phase of the result CZT. This relates to the where the center of the destination + array should be. The default is `nothing` which means it is calculated from the `src_center` argument. + `w`: defines the consecutive phases of the result array, i.e. the zoom. It is (default `nothing`) usually automatically calculated from the `scaled` and the `damp` argument. You only need to state it, if you want to use the low-level interface (e.g. for the Laplace transform). + `damp`: a multiplicative factor to apply as a damping coefficient to `w`. -+ `src_center`: position of the nominal central (zero-position) pixel in the source array. By default the Fourier-center `size(src).÷2 .+1` is used. -+ `dst_center`: the center (zero-position) of the destination array. By default the Fourier-center `size(dst).÷2 .+1` is used. ++ `src_center`: position of the nominal central (zero-position) pixel in the source array. By default the F + ourier-center `size(src).÷2 .+1` is used. ++ `dst_center`: the center (zero-position) of the destination array. By default the + Fourier-center `size(dst).÷2 .+1` is used. ++ `extra_phase`: a phase ramp to apply to the final result relating to the src_center. By default `nothing` which calculates this phase according to the `src_center`. ++ `global_phase`: the initial phase of the destitation array. By default `nothing` which calculates this phase according to the centers. + `remove_wrap`: if true, the positions that represent a wrap-around will be set to zero + `pad_value`: the value to pad wrapped data with. """ -function czt_1d(xin, scaled, d, dsize=size(xin,d); a=nothing, w=nothing, damp=1.0, src_center=size(xin,d)÷2+1, dst_center=dsize÷2+1, remove_wrap=false, pad_value=zero(eltype(xin)), fft_flags=FFTW.ESTIMATE) - plan = plan_czt_1d(xin, scaled, d, dsize; a=a, w=w, damp, src_center=src_center, dst_center=dst_center, remove_wrap=remove_wrap, pad_value=pad_value, fft_flags=fft_flags); +function czt_1d(xin, scaled, d, dsize=size(xin,d); a=nothing, w=nothing, damp=1.0, src_center=size(xin,d)÷2+1, + dst_center=dsize÷2+1, extra_phase=nothing, global_phase=nothing, remove_wrap=false, pad_value=zero(eltype(xin)), fft_flags=FFTW.ESTIMATE) + plan = plan_czt_1d(xin, scaled, d, dsize; a=a, w=w, extra_phase=extra_phase, global_phase=global_phase, damp, src_center=src_center, dst_center=dst_center, remove_wrap=remove_wrap, pad_value=pad_value, fft_flags=fft_flags); return plan * xin end @@ -278,7 +292,8 @@ function czt_1d(xin, plan::CZTPlan_1D) end """ - czt(xin, scale, dims=1:ndims(xin), dsize=size(xin,d); a=nothing, w=nothing, damp=ones(ndims(xin)), src_center=size(xin,d)÷2+1, dst_center=dsize÷2+1, remove_wrap=false, fft_flags=FFTW.ESTIMATE) + czt(xin, scale, dims=1:ndims(xin), dsize=size(xin,d); a=nothing, w=nothing, damp=ones(ndims(xin)), + src_center=size(xin,d)÷2+1, dst_center=dsize÷2+1, remove_wrap=false, fft_flags=FFTW.ESTIMATE) Chirp z transform of the ND array `xin` The tuple `scale` defines the zoom factors in the Fourier domain. Each has to be bigger than one. @@ -292,13 +307,16 @@ The code is based on Rabiner, Schafer & Rader 1969, IEEE Trans. on Audio and El Note that a factor of nothing (or 1.0) needs to be provided, if a dimension is not transformed. + `dims`: a tuple of dimensions over which to apply the czt. + `dsize`: a tuple specifying the destination size -+ `a`: defines the starting phase of the result CZT. This relates to the where the center of the destination array should be. - The default is `nothing` which means it is calculated from the `src_center` argument. -+ `w`: defines the consecutive phases of the result array, i.e. the zoom. It is (default `nothing`) usually automatically calculated from the `scaled` and the `damp` argument. ++ `a`: defines the starting phase of the result CZT. This relates to the where the center of the destination + array should be. The default is `nothing` which means it is calculated from the `src_center` argument. ++ `w`: defines the consecutive phases of the result array, i.e. the zoom. It is (default `nothing`) + usually automatically calculated from the `scaled` and the `damp` argument. You only need to state it, if you want to use the low-level interface (e.g. for the Laplace transform). + `damp`: a multiplicative factor to apply as a damping coefficient to `w`. -+ `src_center`: position of the nominal central (zero-position) pixel in the source array. By default the Fourier-center `size(src).÷2 .+1` is used. -+ `dst_center`: the center (zero-position) of the destination array. By default the Fourier-center `size(dst).÷2 .+1` is used. ++ `src_center`: position of the nominal central (zero-position) pixel in the source array. By default the + Fourier-center `size(src).÷2 .+1` is used. ++ `dst_center`: the center (zero-position) of the destination array. By default the + Fourier-center `size(dst).÷2 .+1` is used. + `remove_wrap`: if true, the positions that represent a wrap-around will be set to zero # Example: @@ -355,7 +373,8 @@ function czt(xin::AbstractArray{T,N}, scale, dims=1:ndims(xin), dsize=size(xin); end """ - iczt(xin ,scale, dims=1:length(size(xin)), dsize=size(xin,d); a=nothing, w=nothing, damp=1.0, src_center=size(xin,d)÷2+1, dst_center=dsize÷2+1, remove_wrap=false, fft_flags=FFTW.ESTIMATE) + iczt(xin ,scale, dims=1:length(size(xin)), dsize=size(xin,d); a=nothing, w=nothing, damp=1.0, + src_center=size(xin,d)÷2+1, dst_center=dsize÷2+1, remove_wrap=false, fft_flags=FFTW.ESTIMATE) Inverse chirp z transform of the ND array `xin` The tuple `scale` defines the zoom factors in the Fourier domain. Each has to be bigger than one. @@ -366,13 +385,16 @@ The code is based on Rabiner, Schafer & Rader 1969, IEEE Trans. on Audio and El + `scaled`: factor to zoom into during the 1-dimensional czt. + `d`: single dimension to transform (as a tuple) + `dsize`: size of the destination array -+ `a`: defines the starting phase of the result CZT. This relates to the where the center of the destination array should be. - The default is `nothing` which means it is calculated from the `src_center` argument. -+ `w`: defines the consecutive phases of the result array, i.e. the zoom. It is (default `nothing`) usually automatically calculated from the `scaled` and the `damp` argument. ++ `a`: defines the starting phase of the result CZT. This relates to the where the center of the destination + array should be. The default is `nothing` which means it is calculated from the `src_center` argument. ++ `w`: defines the consecutive phases of the result array, i.e. the zoom. It is (default `nothing`) usually + automatically calculated from the `scaled` and the `damp` argument. You only need to state it, if you want to use the low-level interface (e.g. for the Laplace transform). + `damp`: a multiplicative factor to apply as a damping coefficient to `w`. -+ `src_center`: position of the nominal central (zero-position) pixel in the source array. By default the Fourier-center `size(src).÷2 .+1` is used. -+ `dst_center`: the center (zero-position) of the destination array. By default the Fourier-center `size(dst).÷2 .+1` is used. ++ `src_center`: position of the nominal central (zero-position) pixel in the source array. By default the + Fourier-center `size(src).÷2 .+1` is used. ++ `dst_center`: the center (zero-position) of the destination array. By default the + Fourier-center `size(dst).÷2 .+1` is used. + `remove_wrap`: if true, the positions that represent a wrap-around will be set to zero + `pad_value`: the value to pad wrapped data with. From a22527547b5e03408d89dbc678414f799106595e Mon Sep 17 00:00:00 2001 From: roflmaostc Date: Tue, 21 Mar 2023 14:54:31 +0100 Subject: [PATCH 6/8] Remove wrong rule to fix issue #35 --- src/convolutions.jl | 12 ------------ 1 file changed, 12 deletions(-) diff --git a/src/convolutions.jl b/src/convolutions.jl index 38585b6..75d2353 100644 --- a/src/convolutions.jl +++ b/src/convolutions.jl @@ -74,18 +74,6 @@ function conv_psf(u::AbstractArray{T, N}, psf::AbstractArray{D, M}, dims=ntuple( return conv(u, ifftshift(psf, dims), dims) end - # define custom adjoint for conv - # so far only defined for the derivative regarding the first component -function ChainRulesCore.rrule(::typeof(conv), u::AbstractArray{T, N}, v::AbstractArray{D, M}, - dims=ntuple(+, min(N, M))) where {T, D, N, M} - Y = conv(u, v, dims) - function conv_pullback(barx) - z = zero(eltype(u)) - return NoTangent(), conv(barx, conj(v), dims), z, z - end - return Y, conv_pullback -end - """ From 79cd82a79e680d843fad81ec15f126dd5830b6a2 Mon Sep 17 00:00:00 2001 From: roflmaostc Date: Tue, 21 Mar 2023 16:15:02 +0100 Subject: [PATCH 7/8] Remove another wrong rule --- src/convolutions.jl | 9 --------- 1 file changed, 9 deletions(-) diff --git a/src/convolutions.jl b/src/convolutions.jl index 75d2353..1081b34 100644 --- a/src/convolutions.jl +++ b/src/convolutions.jl @@ -207,15 +207,6 @@ function p_conv_aux(P, P_inv, u, v_ft) return (P_inv.p * ((P * u) .* v_ft .* P_inv.scale)) end -function ChainRulesCore.rrule(::typeof(p_conv_aux), P, P_inv, u, v) - Y = p_conv_aux(P, P_inv, u, v) - function conv_pullback(barx) - z = zero(eltype(u)) - ∇ = p_conv_aux(P, P_inv, barx, conj(v)) - return NoTangent(), z, z, ∇, z - end - return Y, conv_pullback -end """ fft_or_rfft(T) From 70ec7bf6c7bd01043a3709567b63db56c1084927 Mon Sep 17 00:00:00 2001 From: "Felix Wechsler (he/him)" Date: Tue, 16 May 2023 12:05:54 +0200 Subject: [PATCH 8/8] Update Project.toml --- Project.toml | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/Project.toml b/Project.toml index f382817..a739cf0 100644 --- a/Project.toml +++ b/Project.toml @@ -1,7 +1,7 @@ name = "FourierTools" uuid = "b18b359b-aebc-45ac-a139-9c0ccbb2871e" authors = ["Felix Wechsler (roflmaostc) ", "rheintzmann "] -version = "0.4.1" +version = "0.4.2" [deps] ChainRulesCore = "d360d2e6-b24c-11e9-a2a3-2a2ae2dbcce4"