From 5cacd9b034913bcd84339be76cd421f2a6d66521 Mon Sep 17 00:00:00 2001
From: Antoine Hoffmann <antoine.hoffmann@epfl.ch>
Date: Thu, 13 Oct 2022 15:17:29 +0200
Subject: [PATCH] scripts save

---
 matlab/extract_fig_data.m                     |  2 +-
 matlab/plot/plot_cosol_mat.m                  | 59 +++++++------------
 .../plot_radial_transport_and_spacetime.m     | 10 +++-
 matlab/setup.m                                |  6 +-
 matlab/write_fort90.m                         |  1 +
 testcases/linear_1D_entropy_mode.m            | 59 +++++++++++--------
 wk/Zpinch_coll_scan_kN_1.7.m                  | 56 ++++++++++++++----
 wk/analysis_gene.m                            |  2 +-
 wk/analysis_gyacomo.m                         | 14 +++--
 wk/header_2DZP_results.m                      |  6 +-
 10 files changed, 125 insertions(+), 90 deletions(-)

diff --git a/matlab/extract_fig_data.m b/matlab/extract_fig_data.m
index 7cd704c8..b9d69af1 100644
--- a/matlab/extract_fig_data.m
+++ b/matlab/extract_fig_data.m
@@ -4,7 +4,7 @@
 % tw = [3000 4000];
 % tw = [4000 4500];
 % tw = [4500 5000];
-tw = [0 6500];
+tw = [500 1000];
 
 fig = gcf;
 axObjs = fig.Children;
diff --git a/matlab/plot/plot_cosol_mat.m b/matlab/plot/plot_cosol_mat.m
index d950808d..f10777e3 100644
--- a/matlab/plot/plot_cosol_mat.m
+++ b/matlab/plot/plot_cosol_mat.m
@@ -66,8 +66,8 @@ subplot(224)
     %% FCGK
 P_ = 4; J_ = 2;
 % mat_file_name = '/home/ahoffman/cosolver/gk.coulomb_NFLR_12_P_4_J_2_N_50_kpm_4.0.h5';
-% mat_file_name = '/home/ahoffman/HeLaZ/iCa/gk_coulomb_NFLR_12_P_4_J_2_N_50_kpm_4.0.h5';
-mat_file_name = '/home/ahoffman/HeLaZ/iCa/LDGK_P10_J5_dk_5e-2_km_5_NFLR_12.h5';
+mat_file_name = '/home/ahoffman/gyacomo/iCa/gk_coulomb_NFLR_12_P_4_J_2_N_50_kpm_4.0.h5';
+% mat_file_name = '/home/ahoffman/gyacomo/iCa/LDGK_P10_J5_dk_5e-2_km_5_NFLR_12.h5';
 
 kp = 2.0;
 kp_a =  h5read(mat_file_name,'/coordkperp');
@@ -92,49 +92,30 @@ subplot(223)
 subplot(224)
     imagesc(imag(MAT)<0);
     title('imag$<$0');
-    
-%% Single eigenvalue analysis
-
-% mat_file_name = '/home/ahoffman/cosolver/gk.coulomb_NFLR_20_P_4_J_2_N_50_kpm_4.0/scanfiles_00005/self.0.h5';
-mat_file_name = '/home/ahoffman/HeLaZ/iCa/gk.coulomb_NFLR_20_P_6_J_3_N_50_kpm_4.0/scanfiles_00042/self.0.h5';
-
-matidx = 01;
-
-matidx = sprintf('%5.5i',matidx);disp(matidx);
-
-% MAT = h5read(mat_file_name,['/',matidx,'/Caapj/Ciipj']);
-MAT = h5read(mat_file_name,['/Caapj/Ciipj']);
-
-gmax = max(real(eig(MAT)));
 
-wmax = max(imag(eig(MAT)));
-figure
-subplot(121)
-imagesc((MAT)); colormap(bluewhitered)
-title(['$\gamma_{max}=',num2str(gmax),'$'])
-subplot(122)
-plot(real(eig(MAT)),imag(eig(MAT)),'x')
 %% Eigenvalue spectrum analysis    
 if 0
 %%
-mfns = {'/home/ahoffman/HeLaZ/iCa/gk_sugama_P_20_J_10_N_150_kpm_8.0.h5',...
-        '/home/ahoffman/HeLaZ/iCa/gk_pitchangle_8_P_20_J_10_N_150_kpm_8.0.h5',...
-        '/home/ahoffman/HeLaZ/iCa/LDGK_P10_J5_dk_5e-2_km_5_NFLR_4.h5',...
-        '/home/ahoffman/HeLaZ/iCa/LDGK_P10_J5_dk_5e-2_km_5_NFLR_12.h5',...
-        '/home/ahoffman/HeLaZ/iCa/LDGK_P10_J5_dk_5e-2_km_5_NFLR_12_k2trunc.h5',...
-        '/home/ahoffman/HeLaZ/iCa/LDGK_P10_J5_dk_5e-2_km_5_NFLR_30.h5',...
-        '/home/ahoffman/HeLaZ/iCa/gk_coulomb_NFLR_6_P_4_J_2_N_50_kpm_4.0.h5',...
-        '/home/ahoffman/HeLaZ/iCa/gk_coulomb_NFLR_12_P_4_J_2_N_50_kpm_4.0.h5',...
-%         '/home/ahoffman/HeLaZ/iCa/gk.hacked_sugama_P_10_J_5_N_150_kpm_8.0.h5',...
-%         '/home/ahoffman/HeLaZ/iCa/gk.hacked_sugama_P_4_J_2_N_75_kpm_5.0.h5',...
+mfns = {...
+        '/home/ahoffman/gyacomo/iCa/gk_sugama_P_20_J_10_N_150_kpm_8.0.h5',...
+%         '/home/ahoffman/gyacomo/iCa/gk_pitchangle_8_P_20_J_10_N_150_kpm_8.0.h5',...
+%         '/home/ahoffman/gyacomo/iCa/LDGK_P10_J5_dk_5e-2_km_5_NFLR_4.h5',...
+%         '/home/ahoffman/gyacomo/iCa/LDGK_P10_J5_dk_5e-2_km_5_NFLR_12.h5',...
+%         '/home/ahoffman/gyacomo/iCa/LDGK_P10_J5_dk_5e-2_km_5_NFLR_12_k2trunc.h5',...
+        '/home/ahoffman/gyacomo/iCa/LDGK_P10_J5_dk_5e-2_km_5_NFLR_30.h5',...
+%         '/home/ahoffman/gyacomo/iCa/gk_coulomb_NFLR_6_P_4_J_2_N_50_kpm_4.0.h5',...
+        '/home/ahoffman/gyacomo/iCa/gk_coulomb_NFLR_12_P_4_J_2_N_50_kpm_4.0.h5',...
+%         '/home/ahoffman/gyacomo/iCa/gk.hacked_sugama_P_10_J_5_N_150_kpm_8.0.h5',...
+%         '/home/ahoffman/gyacomo/iCa/gk.hacked_sugama_P_4_J_2_N_75_kpm_5.0.h5',...
         };
-CONAME_A = {'SG 20 10',...
-    'PA 20 10',...
-    'FC 10  5 NFLR 4',...
-    'FC 10  5 NFLR 12',...
-    'FC 10  5 NFLR 12 k<2', ...
+CONAME_A = {...
+    'SG 20 10',...
+%     'PA 20 10',...
+%     'FC 10  5 NFLR 4',...
+%     'FC 10  5 NFLR 12',...
+%     'FC 10  5 NFLR 12 k<2', ...
     'FC 10  5 NFLR 30', ...
-    'FC 4 2 NFLR 6',...
+%     'FC 4 2 NFLR 6',...
     'FC 4 2 NFLR 12', ...
 %     'Hacked SG A',...
 %     'Hacked SG B',...
diff --git a/matlab/plot/plot_radial_transport_and_spacetime.m b/matlab/plot/plot_radial_transport_and_spacetime.m
index 5ea5cbc5..6f5e6402 100644
--- a/matlab/plot/plot_radial_transport_and_spacetime.m
+++ b/matlab/plot/plot_radial_transport_and_spacetime.m
@@ -75,11 +75,15 @@ mvm = @(x) movmean(x,OPTIONS.NMVA);
 %     yyaxis right
         plot(mvm(DATA.Ts0D),mvm(DATA.HFLUX_X*SCALE),'DisplayName','$\langle n_i \partial_y\phi \rangle_y$'); hold on;
 %         plot(mvm(DATA.Ts3D),mvm(Qx_t_mtlb),'DisplayName','matlab comp.'); hold on;
+        ylabel('Transport')  
+        if(~isnan(Qx_infty_avg))
         plot(DATA.Ts0D(its0D:ite0D),ones(ite0D-its0D+1,1)*Qx_infty_avg, '-k',...
             'DisplayName',['$Q_{avg}=',sprintf('%2.2f',Qx_avg),'\pm',sprintf('%2.2f',Qx_err),'$']); legend('show');
-        ylabel('$Q_x$')  
-        if(~isnan(Qx_infty_avg))
-        ylim([0,5*abs(Qx_infty_avg)]); 
+            ylim([0,5*abs(Qx_infty_avg)]); 
+        else
+        plot(DATA.Ts0D(its0D:ite0D),ones(ite0D-its0D+1,1)*Gx_infty_avg, '-k',...
+            'DisplayName',['$\Gamma_{avg}=',sprintf('%2.2f',Gx_infty_avg),'\pm',sprintf('%2.2f',Gx_infty_std),'$']); legend('show');
+            ylim([0,5*abs(Gx_infty_avg)]); 
         end
         xlim([DATA.Ts0D(1),DATA.Ts0D(end)]);
     grid on; set(gca,'xticklabel',[]); 
diff --git a/matlab/setup.m b/matlab/setup.m
index edba5849..966b6fbd 100644
--- a/matlab/setup.m
+++ b/matlab/setup.m
@@ -63,11 +63,11 @@ switch CO
     case 'LR'
         COLL.mat_file = '''../../../iCa/gk_pitchangle_8_P_20_J_10_N_150_kpm_8.0.h5''';
     case 'LD'
-%         COLL.mat_file = '''../../../iCa/gk_coulomb_NFLR_12_P_4_J_2_N_75_kpm_6.0.h5''';
 %         COLL.mat_file = '''../../../iCa/gk_coulomb_NFLR_12_P_4_J_2_N_50_kpm_4.0.h5''';
-        COLL.mat_file = '''../../../iCa/LDGK_P10_J5_dk_5e-2_km_5_NFLR_12_k2trunc.h5''';
-%         COLL.mat_file = '''../../../iCa/LDGK_P10_J5_dk_5e-2_km_5_NFLR_4.h5''';
+%         COLL.mat_file = '''../../../iCa/LDGK_P10_J5_dk_5e-2_km_5_NFLR_12_k2trunc.h5''';
+        COLL.mat_file = '''../../../iCa/LDGK_P10_J5_dk_5e-2_km_5_NFLR_30.h5''';        
 end
+COLL.coll_kcut = COLL_KCUT;
 % Time integration and intialization parameters
 TIME_INTEGRATION.numerical_scheme  = '''RK4''';
 INITIAL.INIT_OPT = ['''',INIT_OPT,''''];
diff --git a/matlab/write_fort90.m b/matlab/write_fort90.m
index 69fe008d..d42c7800 100644
--- a/matlab/write_fort90.m
+++ b/matlab/write_fort90.m
@@ -84,6 +84,7 @@ fprintf(fid,['  collision_model = ', COLL.collision_model,'\n']);
 fprintf(fid,['  gyrokin_CO      = ', COLL.gyrokin_CO,'\n']);
 fprintf(fid,['  interspecies    = ', COLL.interspecies,'\n']);
 fprintf(fid,['  mat_file        = ', COLL.mat_file,'\n']);
+fprintf(fid,['  collision_kcut  = ', num2str(COLL.coll_kcut),'\n']);
 fprintf(fid,'/\n');
 
 
diff --git a/testcases/linear_1D_entropy_mode.m b/testcases/linear_1D_entropy_mode.m
index f32cb24e..e6008157 100644
--- a/testcases/linear_1D_entropy_mode.m
+++ b/testcases/linear_1D_entropy_mode.m
@@ -6,24 +6,30 @@ default_plots_options
 CLUSTER.TIME  = '99:00:00'; % allocation time hh:mm:ss
 %%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
 %% PHYSICAL PARAMETERS
-NU      = 0.01;   % Collision frequency
+NU      = 0.1;   % Collision frequency
 TAU     = 1.0;    % e/i temperature ratio
-K_N     = 2.0;   % Density gradient drive
-K_T     = 0.25*K_N;   % Temperature '''
+K_Ne    = 2.0;   % Density gradient drive
+K_Ni    = 2.0;   % Density gradient drive
+K_Te    = 0.25*K_Ne;   % Temperature '''
+K_Ti    = 0.25*K_Ni;   % Temperature '''
 K_E     = 0.0;   % Electrostat '''
 SIGMA_E = 0.0233380;   % mass ratio sqrt(m_a/m_i) (correct = 0.0233380)
+BETA    = 0;
 %% GRID PARAMETERS
-NX      = 40;     % real space x-gridpoints
-NY      = 1;     %     ''     y-gridpoints
+NX      = 2;     % real space x-gridpoints
+NY      = 80;     %     ''     y-gridpoints
 LX      = 120;     % Size of the squared frequency domain
-LY      = 1;     % Size of the squared frequency domain
+LY      = 120;     % Size of the squared frequency domain
 NZ      = 1;      % number of perpendicular planes (parallel grid)
-SG      = 1;         % Staggered z grids option
+SG      = 0;         % Staggered z grids option
 %% GEOMETRY
 GEOMETRY= 'Z-pinch';
 Q0      = 1.0;    % safety factor
 SHEAR   = 0.0;    % magnetic shear
 EPS     = 0.0;    % inverse aspect ratio
+NEXC    = 1;
+NPOL    = 1;
+COLL_KCUT = 1.8;
 %% TIME PARMETERS
 TMAX    = 100;  % Maximal time unit
 DT      = 1e-2;   % Time step
@@ -39,8 +45,8 @@ LINEARITY = 'linear';   % activate non-linearity (is cancelled if KXEQ0 = 1)
 KIN_E   = 1;
 % Collision operator
 % (LB:L.Bernstein, DG:Dougherty, SG:Sugama, LR: Lorentz, LD: Landau)
-CO      = 'DG';
-GKCO    = 0; % gyrokinetic operator
+CO      = 'LR';
+GKCO    = 1; % gyrokinetic operator
 ABCO    = 1; % interspecies collisions
 INIT_ZF = 0; ZF_AMP = 0.0;
 CLOS    = 0;   % Closure model (0: =0 truncation, 1: gyrofluid closure (p+2j<=Pmax))s
@@ -59,6 +65,7 @@ W_NAPJ   = 1; W_SAPJ   = 0;
 HD_CO   = 0.0;    % Hyper diffusivity cutoff ratio
 kmax    = NX*pi/LX;% Highest fourier mode
 MU      = 0.0; % Hyperdiffusivity coefficient
+N_HD    = 4;
 INIT_BLOB = 0; WIPE_TURB = 0; ACT_ON_MODES = 0;
 MU_X    = MU;     % 
 MU_Y    = MU;     % 
@@ -74,8 +81,8 @@ CURVB   = 1.0;
 
 if 1
 % Parameter scan over PJ
-PA = [4];
-JA = [2];
+PA = [10];
+JA = [5];
 Nparam = numel(PA);
 % Parameter scan over KN
 % PA = [4]; JA = [2];
@@ -88,9 +95,9 @@ Nparam = numel(PA);
 DTA= DT*ones(1,Nparam)./sqrt(JA);
 % DTA= DT;
 param_name = 'KN';
-gamma_Ni00 = zeros(Nparam,floor(NX/2)+1);
-gamma_Nipj = zeros(Nparam,floor(NX/2)+1);
-gamma_phi  = zeros(Nparam,floor(NX/2)+1);
+gamma_Ni00 = zeros(Nparam,numel(ky));
+gamma_Nipj = zeros(Nparam,numel(ky));
+gamma_phi  = zeros(Nparam,numel(ky));
 for i = 1:Nparam
     % Change scan parameter
     PMAXE = PA(i); PMAXI = PA(i);
@@ -101,7 +108,7 @@ for i = 1:Nparam
     system(['rm fort*.90']);
     % Run linear simulation
     if RUN
-        system(['cd ../results/',SIMID,'/',PARAMS,'/; mpirun -np 1 ./../../../bin/helaz3 1 1 1 0; cd ../../../wk'])
+        system(['cd ../results/',SIMID,'/',PARAMS,'/; mpirun -np 4 ./../../../bin/gyacomo 1 4 1 0; cd ../../../wk'])
 % disp([param_name,'=',num2str(K_N)]);
 % system(['cd ../results/',SIMID,'/',PARAMS,'/; mpirun -np 6 ./../../../bin/helaz3 1 6 0 > out.txt; cd ../../../wk']);
 %         system(['cd ../results/',SIMID,'/',PARAMS,'/; mpirun -np 2 ./../../../bin/helaz 1 2 0; cd ../../../wk'])
@@ -111,27 +118,27 @@ for i = 1:Nparam
     %%
     filename = ['../results/',SIMID,'/',PARAMS,'/outputs_00.h5'];
     load_results
-    for ikx = 1:NX/2+1
-        tend   = max(Ts3D(abs(Ni00(ikx,1,1,:))~=0));
+    for iky = 1:numel(ky)
+        tend   = max(Ts3D(abs(Ni00(iky,1,1,:))~=0));
         tstart   = 0.6*tend;
         [~,itstart] = min(abs(Ts3D-tstart));
         [~,itend]   = min(abs(Ts3D-tend));
         trange = itstart:itend;
         % exp fit on moment 00
-        X_ = Ts3D(trange); Y_ = squeeze(abs(Ni00(ikx,1,1,trange)));
-        gamma_Ni00(i,ikx) = LinearFit_s(X_,Y_);
+        X_ = Ts3D(trange); Y_ = squeeze(abs(Ni00(iky,1,1,trange)));
+        gamma_Ni00(i,iky) = LinearFit_s(X_,Y_);
         % exp fit on phi
-        X_ = Ts3D(trange); Y_ = squeeze(abs(PHI(ikx,1,1,trange)));
-        gamma_phi (i,ikx) = LinearFit_s(X_,Y_);
+        X_ = Ts3D(trange); Y_ = squeeze(abs(PHI(iky,1,1,trange)));
+        gamma_phi (i,iky) = LinearFit_s(X_,Y_);
     end
     gamma_Ni00(i,:) = real(gamma_Ni00(i,:));% .* (gamma_Ni00(i,:)>=0.0));
     gamma_Nipj(i,:) = real(gamma_Nipj(i,:));% .* (gamma_Nipj(i,:)>=0.0));
     if 0
     %% Fit verification
     figure;
-    for i = 1:1:NX/2+1
+    for i = 1:1:numel(ky)
         X_ = Ts3D(:); Y_ = squeeze(abs(Ni00(i,1,1,:)));
-        semilogy(X_,Y_,'DisplayName',['k=',num2str(kx(i))]); hold on;
+        semilogy(X_,Y_,'DisplayName',['k_y=',num2str(ky(i))]); hold on;
     end
 end
 
@@ -146,15 +153,15 @@ plt = @(x) x;
         colors = jet(Nparam);
         clr       = colors(mod(i-1,numel(line_colors(:,1)))+1,:);
         linestyle = line_styles(floor((i-1)/numel(line_colors(:,1)))+1);
-        plot(plt(SCALE*kx),plt(gamma_phi(i,1:end)),...
+        plot(plt(SCALE*ky),plt(gamma_phi(i,1:end)),...
             'Color',clr,...
             'LineStyle',linestyle{1},'Marker','^',...
 ...%             'DisplayName',['$\kappa_N=',num2str(K_N),'$, $\nu_{',CONAME,'}=',num2str(NU),'$, $P=',num2str(PA(i)),'$, $J=',num2str(JA(i)),'$']);
             'DisplayName',[CONAME,', $P,J=',num2str(PA(i)),',',num2str(JA(i)),'$']);
         hold on;
     end
-    grid on; xlabel('$k_y\rho_s^{R}$'); ylabel('$\gamma(\phi)L_\perp/c_s$'); xlim([0.0,max(kx)]);
-    title(['$\kappa_N=',num2str(K_N),'$, $\nu_{',CONAME,'}=',num2str(NU),'$'])
+    grid on; xlabel('$k_y\rho_s^{R}$'); ylabel('$\gamma(\phi)L_\perp/c_s$'); xlim([0.0,max(ky)]);
+    title(['$\kappa_N=',num2str(K_Ni),'$, $\nu_{',CONAME,'}=',num2str(NU),'$'])
     legend('show'); %xlim([0.01,10])
 saveas(fig,[SIMDIR,'/',PARAMS,'/gamma_vs_',param_name,'_',PARAMS,'.fig']);
 saveas(fig,[SIMDIR,'/',PARAMS,'/gamma_vs_',param_name,'_',PARAMS,'.png']);
diff --git a/wk/Zpinch_coll_scan_kN_1.7.m b/wk/Zpinch_coll_scan_kN_1.7.m
index b849c259..e223e0e4 100644
--- a/wk/Zpinch_coll_scan_kN_1.7.m
+++ b/wk/Zpinch_coll_scan_kN_1.7.m
@@ -1,32 +1,68 @@
+%%
+if 0
 figure
 
 Kn = 1.7;
 
-% SUGAMA 4,2
-nu_a   = 1e-2*[1.00 2.00 3.00 4.00 5.00 6.00 7.00 10.0];
-Gavg_a = 1e-2*[1.00 1.71 2.18 3.11 4.11 5.20 6.08  5.59*Kn];
-Gstd_a = 1e-2*[1.78 2.67 2.82 3.08 2.33 1.35 1.43  0.0];
+% SUGAMA DK 4,2
+% nu_a   = 1e-2*[1.00 2.00 3.00 4.00 5.00 6.00 7.00];
+% Gavg_a = 1e-2*[1.00 1.71 2.18 3.11 4.11 5.20 6.08];
+% Gstd_a = 1e-2*[1.78 2.67 2.82 3.08 2.33 1.35 1.43];
+
+% errorbar(nu_a, Gavg_a/Kn, Gstd_a/Kn,'DisplayName','Sugama DK (4,2)'); hold on
+
+% SUGAMA GK 4,2
+nu_a   = 1e-2*[1.00 2.00 3.00 4.00 5.00 6.00 7.00 8.00 9.00 10.0];
+Gavg_a = [2.54e-2 4.66e-2 6.96e-2 8.98e-2 1.06e-1 1.24e-1 1.43e-1 1.52e-1 1.69e-1  1.09e-1];
+Gstd_a = [3.04e-2 1.42e-2 1.56e-2 1.23e-2 1.20e-2 1.57e-2 1.63e-2 2.06e-2 2.14e-02 1.78e-2];
+
+errorbar(nu_a, Gavg_a/Kn, Gstd_a/Kn,'DisplayName','Sugama GK (4,2)'); hold on
 
-errorbar(nu_a, Gavg_a/Kn, Gstd_a/Kn,'DisplayName','Sugama (4,2)'); hold on
 
-% LANDAU 4,2
+% FCGK 4,2
 nu_a   = 1e-2*[1.00 2.00 3.00 4.00 5.00 6.00 7.00 10.0];
 Gavg_a = [8.57e-2 1.45e-1 2.25e-1 2.87e-1 3.48e-1 4.06e-1 4.51e-1 3.65e-1*Kn];
 Gstd_a = [2.07e-2 2.61e-2 2.40e-2 3.46e-2 4.30e-2 5.00e-2 5.11e-2  0];
 
 errorbar(nu_a, Gavg_a/Kn, Gstd_a/Kn,'DisplayName','Coulomb (4,2)'); hold on
 
-% LANDAU 6,3
+% LDGK ii 6,3
 nu_a   = 1e-2*[1.00 2.00 3.00 4.00 5.00 6.00 7.00 8.00 9.00];
 Gavg_a = [3.86e-2 1.82e-2 3.08e-2 5.24e-2 7.08e-2 8.26e-2 5.78e-2 7.16e-2 7.96e-2];
 Gstd_a = [3.52e-2 1.87e-2 2.86e-2 2.79e-2 1.72e-2 2.40e-2 2.46e-2 1.01e-2 1.21e-2];
 
-errorbar(nu_a, Gavg_a/Kn, Gstd_a/Kn,'DisplayName','Coulomb (6,3)'); hold on
+errorbar(nu_a, Gavg_a/Kn, Gstd_a/Kn,'DisplayName','Landau ii (6,3)'); hold on
 
 % Collisionless
 plot([0 1], 0.02343*[1 1],'--k','DisplayName','$\nu=0$');
 
 
 %
-xlim([min(nu_a) max(nu_a)]);
-xlabel('$\nu R/c_s$'); ylabel('$\Gamma_x^\infty/\kappa_N$');
\ No newline at end of file
+xlim([0 0.1]);
+legend('show');
+xlabel('$\nu R/c_s$'); ylabel('$\Gamma_x^\infty/\kappa_N$');
+
+
+end
+if 0
+%%
+figure
+
+nu = 0.1;
+
+% FCGK 4,2
+kn_a   = [1.60 1.80 2.00 2.20 2.40];
+Gavg_a = [1.11e-1 6.86e-1 3.44e-0 1.12e+1 2.87e+1];
+Gstd_a = [7.98e-3 1.10e-1 4.03e-1 2.03e+0 7.36e+0];
+
+errorbar(kn_a, Gavg_a./kn_a, Gstd_a./kn_a,'DisplayName','Coulomb (4,2)'); hold on
+
+% % Collisionless
+% plot([0 1], 0.02343*[1 1],'--k','DisplayName','$\nu=0$');
+
+
+%
+xlim([1.6 2.5]);
+legend('show');
+xlabel('$\nu R/c_s$'); ylabel('$\Gamma_x^\infty/\kappa_N$');
+end
\ No newline at end of file
diff --git a/wk/analysis_gene.m b/wk/analysis_gene.m
index 0c12c27b..f45fc16d 100644
--- a/wk/analysis_gene.m
+++ b/wk/analysis_gene.m
@@ -28,7 +28,7 @@ addpath(genpath([helazdir,'matlab/load'])) % ... add
 % folder = '/misc/gene_results/CBC/KT_9_128x64x16x24x12/';
 % folder = '/misc/gene_results/CBC/KT_13_large_box_128x64x16x24x12/';
 % folder = '/misc/gene_results/CBC/Lapillone_Fig6/';
-folder = '/misc/gene_results/Z-pinch/HP_kN_1.6_adapt_mu/';
+folder = '/misc/gene_results/Z-pinch/HP_kN_1.6_adapt_mu_01/';
 gene_data = load_gene_data(folder);
 gene_data = invert_kxky_to_kykx_gene_results(gene_data);
 if 1
diff --git a/wk/analysis_gyacomo.m b/wk/analysis_gyacomo.m
index cec6c243..eecf7147 100644
--- a/wk/analysis_gyacomo.m
+++ b/wk/analysis_gyacomo.m
@@ -28,7 +28,9 @@ FMT = '.fig';
 if 1
 %% Space time diagramm (fig 11 Ivanov 2020)
 % data.scale = 1;%/(data.Nx*data.Ny)^2;
-i_ = 19; disp([num2str(data.NU_EVOL(i_)),' ',num2str(data.NU_EVOL(i_+1))])
+i_ = 11; 
+disp([num2str(data.TJOB_SE(i_)),' ',num2str(data.TJOB_SE(i_+1))])
+disp([num2str(data.NU_EVOL(i_)),' ',num2str(data.NU_EVOL(i_+1))])
 options.TAVG_0   = data.TJOB_SE(i_);%0.4*data.Ts3D(end);
 options.TAVG_1   = data.TJOB_SE(i_+1);%0.9*data.Ts3D(end); % Averaging times duration
 options.NCUT     = 4;              % Number of cuts for averaging and error estimation
@@ -51,8 +53,8 @@ if 0
 % Options
 options.INTERP    = 1;
 options.POLARPLOT = 0;
-% options.NAME      = '\phi';
-options.NAME      = '\omega_z';
+options.NAME      = '\phi';
+% options.NAME      = '\omega_z';
 % options.NAME      = 'N_i^{00}';
 % options.NAME      = 'v_y';
 % options.NAME      = 'n_i^{NZ}';
@@ -64,11 +66,11 @@ options.PLAN      = 'xy';
 % options.COMP      = 'avg';
 % options.TIME      = data.Ts5D(end-30:end);
 % options.TIME      =  data.Ts3D;
-options.TIME      = [100:1:300];
+options.TIME      = [000:50:7000];
 data.EPS          = 0.1;
 data.a = data.EPS * 2000;
 options.RESOLUTION = 256;
-create_film(data,options,'.avi')
+create_film(data,options,'.gif')
 end
 
 if 1
@@ -88,7 +90,7 @@ options.PLAN      = 'xy';
 % options.NAME      'f_i';
 % options.PLAN      = 'sx';
 options.COMP      = 'avg';
-options.TIME      = [200];
+options.TIME      = [1000 1800 2500 3000 4000];
 
 data.a = data.EPS * 2e3;
 fig = photomaton(data,options);
diff --git a/wk/header_2DZP_results.m b/wk/header_2DZP_results.m
index 3ce42888..b180dd52 100644
--- a/wk/header_2DZP_results.m
+++ b/wk/header_2DZP_results.m
@@ -189,7 +189,11 @@ resdir ='';
 % resdir = 'Zpinch_rerun/UHD_nu_01_LDGK';
 % resdir = 'Zpinch_rerun/UHD_nu_1_LDGK';
 % resdir ='Zpinch_rerun/kN_1.7_SGGK_conv_200x32x7x3_nu_0.01';
-resdir ='Zpinch_rerun/kN_1.7_LDGK_conv_200x32x7x3_nu_0.01';
+% resdir ='Zpinch_rerun/kN_1.7_LDGKii_200x32x7x3_nu_scan';
+% resdir ='Zpinch_rerun/nu_0.1_LDGKii_200x48x7x4_kN_scan';
+resdir ='Zpinch_rerun/nu_0.1_FCGK_200x48x5x3_kN_scan';
+% resdir = 'Zpinch_rerun/kN_1.7_FCGK_200x32x5x3_nu_scan';
+% resdir = 'Zpinch_rerun/kN_1.7_SGGK_200x32x7x4_nu_scan';
 %%
 JOBNUMMIN = 00; JOBNUMMAX = 10;
 resdir = ['results/',resdir];
-- 
GitLab