Browse Source

Transférer les fichiers vers 'matlab'

matlab files
testing
Lilian RM 3 years ago
parent
commit
355fde9fd6
5 changed files with 303 additions and 0 deletions
  1. +15
    -0
      matlab/gen_Wn_coeffs_5ndft.m
  2. +9
    -0
      matlab/radix2.m
  3. +250
    -0
      matlab/tb_generation_5ndft.m
  4. +18
    -0
      matlab/winograd5.m
  5. +11
    -0
      matlab/write_file.m

+ 15
- 0
matlab/gen_Wn_coeffs_5ndft.m View File

@@ -0,0 +1,15 @@
function gen_Wn_coeffs_5ndft(nb_inputs_tot, bitwidth, file)
coeff_format = 'library ieee;\nUSE ieee.std_logic_1164.all;\nUSE work.FIVEn_DFT_PKG.all;\npackage coeff_5ndft is\n TYPE vect_cos_sin_k_pi_over_n_wb IS ARRAY (0 TO cst_nb_wn_coeffs-1) OF smpl_cos_sin_wb ;\n CONSTANT cos_k_pi_over_n_wb : vect_cos_sin_k_pi_over_n_wb := ("';
for i = 0:nb_inputs_tot/2-2
coeff_format = strcat(coeff_format, string(bin(fi(real(exp(-2*1i*pi*i/nb_inputs_tot)),1,bitwidth, bitwidth-2))), '","');
end
coeff_format = strcat(coeff_format, string(bin(fi(real(exp(-2*1i*pi*(nb_inputs_tot/2-1)/nb_inputs_tot)),1,bitwidth, bitwidth-2))), '");\n CONSTANT sin_k_pi_over_n_wb : vect_cos_sin_k_pi_over_n_wb := ("');
for i = 0:nb_inputs_tot/2-2
coeff_format = strcat(coeff_format, string(bin(fi(imag(exp(-2*1i*pi*i/nb_inputs_tot)),1,bitwidth, bitwidth-2))), '","');
end
coeff_format = strcat(coeff_format, string(bin(fi(imag(exp(-2*1i*pi*(nb_inputs_tot/2-1)/nb_inputs_tot)),1,bitwidth, bitwidth-2))), '");\nend package coeff_5ndft;');
fcoeff = fopen(file,'w');
fprintf(fcoeff,coeff_format);
fclose(fcoeff);
end

+ 9
- 0
matlab/radix2.m View File

@@ -0,0 +1,9 @@
function output = radix2(input, wn)
output = 0*input;
for i = 1:size(input,1)/2
s1 = [input(i,:); input(i+(size(input,1)/2),:)*wn(i)];
output(i,:) = s1(1,:)+s1(2,:);
output(i+(size(input,1)/2),:) = s1(1,:)-s1(2,:);
end

+ 250
- 0
matlab/tb_generation_5ndft.m View File

@@ -0,0 +1,250 @@
clear all;
clear;
close all;
rng(1); % random seed
global ns average quantization Q1 Q2 Q2_1 Q2_2 Q3 fs M D sb_nbr Apass Astop dens
%% Parameter
ns = 2e6; % Number of Sample
fs = 40e9; % Sampling Frequency
M = 20; % Polyphase factor
D = 8; % Decimator
sb_nbr = 3; % Sub-band Number in OPFB : 1 -> M
average = 0; % PSD smoothing : 0 = OFF ; 1 = ON
quantization = 1; % 0 = OFF ; 1 = ON
Q1 = 6; % DG Quantization
Q2 = 8; % PF coefficients Quantization
Q2_1 = 8; % TAP Winograd Quantizantion
Q2_2 = 8; % TAP radix2 Quantization
Q3 = 6; % PFB final Quantization
Apass = 0.25; % Passband Ripple (dB)
Astop = 50; % Stopband Attenuation (dB)
dens = 50; % Density Factor
%% Input Signal
bw = fs/M; % OPFB Output Bandwidth
f1 = bw*(sb_nbr);
f2 = bw*(sb_nbr-0.625+0.25*mod(sb_nbr,M/gcd(M,D)));
t = 0:1/fs:(ns-1)/fs;
sw1 = 1*sin(2*pi*f1*t);
sw2 = 1*sin(2*pi*f1*t);
noise = randn([1 ns]);
nsw = noise+sw1+sw2;
% win = hanning(ns);
% if average == 0
% [PSD, FREQ] = periodogram(nsw,win,ns,fs);
% else
% [PSD, FREQ] = pwelch(nsw,ns/100,[],ns,fs);
% end
% figure;
% MAX = max(10*log(PSD));
% plot(FREQ/1e9, 10*log(PSD)-MAX);
% title('Real Input signal');
% xlim([0,fs/1e9]);
% grid on;
%% Digitizer Anti-aliasing Filter
f = [0 0.1 0.9 1];
m = [0 1 1 0];
b = fir2(1000,f,m);
s_dg_real = conv(noise+sw1,b,'valid');
s_dg_imag = conv(noise+sw2,b,'valid');
s_dg_bb = 0*s_dg_real+1i*s_dg_imag;
ns_dg_bb = size(s_dg_bb,2);
if quantization == 1
s_dg_bb_fi = fi(s_dg_bb,1,Q1,0);
s_dg_bb = s_dg_bb_fi.data;
end
win = hanning(ns_dg_bb);
if average == 0
[PSD, FREQ] = periodogram(s_dg_bb,win,ns_dg_bb,fs);
else
[PSD, FREQ] = pwelch(s_dg_bb,ns_dg_bb/100,[],ns_dg_bb,fs);
end
figure;
MAX = max(10*log(PSD));
plot(FREQ/1e9, 10*log(PSD)-MAX);
title('Dual complex input signal');
xlim([0,fs/1e9]);
grid on;
%% Oversampled Polyphase Filter Bank
% All frequency values are in GHz.
Fs = fs/1e9; % Sampling Frequency
Fpass = (1-(1-D/M))*Fs/M; % Passband Frequency
Fstop = Fs/M; % Stopband Frequency
Dpass = 1-10^(-Apass/20); % Passband Ripple
Dstop = 10^(-Astop/20); % Stopband Attenuation
% Calculate the order from the parameters using FIRPMORD.
[N, Fo, Ao, W] = firpmord([Fpass, Fstop]/(Fs), [1 0], [Dpass, Dstop]);
Ndec0 = N;
if (mod(N,M) ~= M-1)
N = N + M-1 - mod(N,M);
end
% Calculate the coefficients using the FIRPM function.
Hdec0 = firpm(N, Fo, Ao, W, {dens});
% Calculate polyphase filter
Hdec0 = fliplr(Hdec0);
len = length(Hdec0);
nrows = len/M;
Hdec0_pol = zeros(M,nrows);
for m=1:M
for i=1:nrows
Hdec0_pol(m,i)=Hdec0(1,(i-1)*M+m);
end
end
if quantization == 1
Hdec0_pol_fi = fi(Hdec0_pol,1,Q2);
Hdec0_pol = Hdec0_pol_fi.data;
end
tb_coeff = reshape(Hdec0_pol*2^(Hdec0_pol_fi.FractionLength), 1, size(Hdec0_pol,1)*size(Hdec0_pol,2));
% Demux Input
ns_dg_rs1 = floor((ns_dg_bb-M)/D);
s_dg_rs1 = zeros(M,ns_dg_rs1);
for m=1:M
for i=1:ns_dg_rs1
s_dg_rs1(m,i) = s_dg_bb(1,(i-1)*D+m);
end
end
s_dg_rs1 = flipud(s_dg_rs1);
% Circular shifting
s_dg_rs2 = s_dg_rs1;
ns_dg_rs2 = ns_dg_rs1;
% for i = 1:ns_dg_rs2
% s_dg_rs2(:,i) = flip((s_dg_bb((i-1)*D+1:(i-1)*D+M))');
% end
for i=1:ns_dg_rs2
for m=1:M
s_dg_rs2(m,i) = s_dg_rs1(1+mod( (m-1) + mod((i-1)*D,M) ,M),i);
end
end
% Apply polyphase filter
ns_pol = ns_dg_rs2-(nrows-1);
s_pol = zeros(M,ns_pol);
for m=1:M
s_pol(m,:) = conv(s_dg_rs2(m,:),Hdec0_pol(m,:),'valid');
end
s_pol = s_pol(:,5:end); % to fit with the VHDL sim vector
ns_pol = ns_pol-4;
s_pol_fi = fi(s_pol,1,19,10+floor(M/20)); % attention, M=20 => 11, M=10 => 10
s_pol = s_pol_fi.data;
% DFT
s_pol_dft = zeros(M,ns_pol);
if M == 10
s_pol_rearranged = [s_pol(1,:); s_pol(3,:); s_pol(5,:); s_pol(7,:); s_pol(9,:); s_pol(2,:); s_pol(4,:); s_pol(6,:); s_pol(8,:); s_pol(10,:)];
elseif M == 20
s_pol_rearranged = [s_pol(1,:); s_pol(5,:); s_pol(9,:); s_pol(13,:); s_pol(17,:); s_pol(3,:); s_pol(7,:); s_pol(11,:); s_pol(15,:); s_pol(19,:); s_pol(2,:); s_pol(6,:); s_pol(10,:); s_pol(14,:); s_pol(18,:); s_pol(4,:); s_pol(8,:); s_pol(12,:); s_pol(16,:); s_pol(20,:)];
end
%%
for i = 1:M/5
s_pol_dft(1+5*(i-1):5*i,:) = winograd5(s_pol_rearranged(1+5*(i-1):5*i,:), 8);
end
wn5 = fi(exp(-2*1i*pi*[0:4]/10), 1, Q2_1, Q2_1-2);
wn5 = wn5.data;
wn10 = fi(exp(-2*1i*pi*[0:9]/20), 1, Q2_2, Q2_2-2);
wn10 = wn10.data;
for i = 1:M/10
s_pol_dft(1+10*(i-1):10*i, :) = radix2(s_pol_dft(1+10*(i-1):10*i, :), wn5);
end
if M == 20
s_pol_dft = radix2(s_pol_dft, wn10);
end
% for i=1:ns_pol
% s_pol_dft(:,i) = fft(s_pol(:,i));
% end
%s_pol_dft(2:end, :) = flip(s_pol_dft(2:end, :));
% for i=1:ns_pol
% for p=1:M
% for m=1:M
% s_pol_dft(p,i) = s_pol_dft(p,i) + s_pol(m,i)*exponential(mod((m-1)*(p-1), M)+1);
% end
% end
% end
tb_input_temp = s_dg_bb*2^s_dg_bb_fi.FractionLength;
tb_input_temp = imag(tb_input_temp(:,M+1:end));
tb_input = zeros(1, length(tb_input_temp));
for i = 1:length(tb_input_temp)
% tb_input(2*i-1) = real(tb_input_temp(i));
tb_input(i) = tb_input_temp(i);
end
tb_output_temp1 = fi(s_pol_dft,1,Q3,Q3-2, 'RoundingMethod', 'Floor');
tb_output_temp = tb_output_temp1.data*2^(tb_output_temp1.FractionLength);
tb_output_temp = reshape(tb_output_temp(6,:), 1, size(tb_output_temp(1,:),1)*size(tb_output_temp(1,:),2));
tb_output = zeros(1, 2*length(tb_output_temp));
for i = 1:length(tb_output_temp)
tb_output(2*i-1) = real(tb_output_temp(i));
tb_output(2*i) = imag(tb_output_temp(i));
end
%% Sub-band Selection
sb_nbr = 9;
%
% if sb_nbr < M/2
% s_pol_sel = s_pol_dft(sb_nbr+1,:)+conj(s_pol_dft(M-sb_nbr+1,:));
% elseif sb_nbr == M/2
% s_pol_sel = s_pol_dft(sb_nbr+1,:);
% if sb_nbr < M
% s_pol_sel = -1i*s_pol_dft(sb_nbr+1,:)+conj(-1i*s_pol_dft(M-sb_nbr+1,:));
% elseif sb_nbr == M
% s_pol_sel = s_pol_dft(1,:);
% end
s_pol_sel = s_pol_dft(sb_nbr,:);
% s_pol_sel = s_pol_dft(sb_nbr+1,:)+conj(s_pol_dft(M-sb_nbr+1,:));
% s_pol_sel = -1i*s_pol_dft(sb_nbr+1,:)+conj(-1i*s_pol_dft(M-sb_nbr+1,:));
s_pol_sel=s_pol_sel.*exp(-1i*pi*[1:ns_pol])/2;
win = hanning(ns_pol);
if average == 0
[PSD, FREQ] = periodogram(s_pol_sel,win,ns_pol,(fs)/D);
else
[PSD, FREQ] = pwelch(s_pol_sel,floor(ns_pol/100),[],ns_pol,(fs)/D);
end
figure;
MAX = max(10*log(PSD));
plot(FREQ/1e9, 10*log(PSD)-MAX);
title('Complex output signal');
xlim([0,(fs)/D/1e9]);
grid on;
%% Printf
demux = M;
file_folder = strcat(pwd, '/tb_txts_files');
write_file(tb_input, strcat(file_folder, '/input.txt'), 80, ' %3d');
write_file(tb_output, strcat(file_folder, '/output.txt'), 20, ' %3d');
gen_Wn_coeffs_5ndft(M, Q2_2, strcat(file_folder, '/coeffs_dft.vhd'));
write_polyfir_coeffs(strcat(file_folder, '/coeffs_fir.vhd'), tb_coeff);

+ 18
- 0
matlab/winograd5.m View File

@@ -0,0 +1,18 @@
function output = winograd55(input, w)
in = [input(1,:); input(4,:); input(5,:); input(3,:); input(2,:)];
s1 = [in(1,:); in(2,:)+in(4,:); in(3,:)+in(5,:); in(2,:)-in(4,:); in(5,:)-in(3,:)];
s2 = [s1(1,:); s1(2,:)+s1(3,:); s1(3,:)-s1(2,:); s1(4,:); s1(5,:); s1(4,:)+s1(5,:)];
mult = [1 (cos(2*pi/5)+cos(4*pi/5))/2-1 (cos(2*pi/5)-cos(4*pi/5))/2 sin(2*pi/5)-sin(4*pi/5) sin(2*pi/5)+sin(4*pi/5) sin(4*pi/5)];
mult = fi(mult, 1, w, w-2);
mult = mult.data;
s4 = [s2(1,:)+s2(2,:); s2(2,:)*mult(2); s2(3,:)*mult(3); s2(4,:)*1i*mult(4); s2(5,:)*1i*mult(5); s2(6,:)*1i*mult(6)];
s5 = [s4(1,:); s4(1,:)+s4(2,:); s4(3,:); s4(4,:); s4(5,:); s4(6,:)];
s6 = [s5(1,:); s5(2,:)-s5(3,:); s5(2,:)+s5(3,:); s5(4,:)+s5(6,:); s5(6,:)-s5(5,:)];
output = [s6(1,:); s6(3,:)+s6(5,:); s6(2,:)-s6(4,:); s6(2,:)+s6(4,:); s6(3,:)-s6(5,:)];
end
function output = radix2(input, w)
s1 = [input(1) input(2)*w];
output = [s1(1)+s1(2) s1(1)-s1(2)];
end

+ 11
- 0
matlab/write_file.m View File

@@ -0,0 +1,11 @@
function write_file(input, file, nb_words_per_line, words_format)
input_format = '';
for i=1:nb_words_per_line
input_format = strcat(input_format,words_format);
end
input_format = strcat(input_format,'\n');
fin = fopen(file,'w');
fprintf(fin,input_format,input);
fclose(fin);
end

Loading…
Cancel
Save