Skip to content
Snippets Groups Projects
Commit 44c272cc authored by Antoine Cyril David Hoffmann's avatar Antoine Cyril David Hoffmann
Browse files

Merge branch 'master' of ssh://c4science.ch/source/HeLaZ

parents 79defc3d 4aa43bbb
No related branches found
No related tags found
No related merge requests found
......@@ -56,5 +56,4 @@ Compilation of HeLaZ
4. next times, for compilation, make is sufficient
Remark for PPB110
- The module list should be at least
1) intel_comp/17.0 2) impi/17.0 3) hdf5/1.8.12_intel13.1
- before compilation do : module purge, then module load ProgEnv-intel/17.0
......@@ -149,7 +149,7 @@ SUBROUTINE load_output
INTEGER :: rank, sz_, n_
INTEGER :: dims(1) = (/0/)
CHARACTER(LEN=50) :: dset_name
INTEGER :: pmaxe_cp, jmaxe_cp, pmaxi_cp, jmaxi_cp
INTEGER :: pmaxe_cp, jmaxe_cp, pmaxi_cp, jmaxi_cp, n0
COMPLEX(dp), DIMENSION(:,:,:,:), ALLOCATABLE :: moments_e_cp
COMPLEX(dp), DIMENSION(:,:,:,:), ALLOCATABLE :: moments_i_cp
! Checkpoint filename
......@@ -163,14 +163,16 @@ SUBROUTINE load_output
CALL getatt(fidrst,"/data/input/" , "jmaxe", jmaxe_cp)
CALL getatt(fidrst,"/data/input/" , "pmaxi", pmaxi_cp)
CALL getatt(fidrst,"/data/input/" , "jmaxi", jmaxi_cp)
CALL getatt(fidrst,"/data/input/" , "jmaxi", jmaxi_cp)
IF (my_id .EQ. 0) WRITE(*,*) "Pe_cp = ", pmaxe_cp
IF (my_id .EQ. 0) WRITE(*,*) "Je_cp = ", jmaxe_cp
CALL getatt(fidrst,"/data/input/" , "start_iframe5d", n0)
! Allocate the required size to load checkpoints moments
CALL allocate_array(moments_e_cp, 1,pmaxe_cp+1, 1,jmaxe_cp+1, ikrs,ikre, ikzs,ikze)
CALL allocate_array(moments_i_cp, 1,pmaxi_cp+1, 1,jmaxi_cp+1, ikrs,ikre, ikzs,ikze)
! Find the last results of the checkpoint file by iteration
n_ = 1
n_ = n0+1
WRITE(dset_name, "(A, '/', i6.6)") "/data/var5d/moments_e", n_ ! start with moments_e/000001
DO WHILE (isdataset(fidrst, dset_name)) ! If n_ is not a file we stop the loop
n_ = n_ + 1
......
%% Load results
if 1
if 0
%%
outfile ='';
outfile ='';
......@@ -191,11 +191,12 @@ if 1
fig = figure; FIGNAME = 'space_time_drphi';set(gcf, 'Position', [100, 100, 1200, 600])
subplot(311)
plot(Ts2D,GFlux_ri); hold on
plot(Ts2D,Bohm_transport*ones(size(Ts2D)),'--'); hold on
plot(Ts5D,PFlux_ri,'.'); hold on
% plot(Ts2D,Bohm_transport*ones(size(Ts2D)),'--'); hold on
ylabel('$\Gamma_r$'); grid on
title(['$\eta=',num2str(ETAB),'\quad',...
'\nu_{',CONAME,'}=',num2str(NU),'$'])
legend(['$P=',num2str(PMAXI),'$, $J=',num2str(JMAXI),'$'],'$\eta\gamma_{max}/k_{max}^2$')
legend(['$P=',num2str(PMAXI),'$, $J=',num2str(JMAXI),'$'],'Particle flux')%'$\eta\gamma_{max}/k_{max}^2$')
set(gca,'xticklabel',[])
subplot(312)
yyaxis left
......
......@@ -18,8 +18,8 @@ PMAXE = 4; % Highest electron Hermite polynomial degree
JMAXE = 4; % Highest '' Laguerre ''
PMAXI = 4; % Highest ion Hermite polynomial degree
JMAXI = 4; % Highest '' Laguerre ''
MU_P = 0; % Hermite hyperdiffusivity -mu_p*(d/dvpar)^4 f
MU_J = 0; % Laguerre hyperdiffusivity -mu_j*(d/dvperp)^4 f
MU_P = 0.1/PMAXI^2; % Hermite hyperdiffusivity -mu_p*(d/dvpar)^4 f
MU_J = 0.1/JMAXI^3; % Laguerre hyperdiffusivity -mu_j*(d/dvperp)^4 f
%% TIME PARAMETERS
TMAX = 600; % Maximal time unit
DT = 2e-2; % Time step
......@@ -36,7 +36,7 @@ JOB2LOAD= 0;
% SIMID = 'test_sapj_cut'; % Name of the simulation
SIMID = 'test_moments_damping'; % Name of the simulation
CO = -3; % Collision operator (0 : L.Bernstein, -1 : Full Coulomb, -2 : Dougherty, -3 : GK Dougherty)
CLOS = 2; % Closure model (0: =0 truncation, 1: semi coll, 2: Copy closure J+1 = J, P+2 = P)
CLOS = 0; % Closure model (0: =0 truncation, 1: semi coll, 2: Copy closure J+1 = J, P+2 = P)
KERN = 0; % Kernel model (0 : GK)
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%%
......
0% Loading or .
You are about to add 0 people to the discussion. Proceed with caution.
Please register or to comment