diff --git a/src/cylindrical_grid.f90 b/src/cylindrical_grid.f90 index 6ae8f79c..67497cd4 100644 --- a/src/cylindrical_grid.f90 +++ b/src/cylindrical_grid.f90 @@ -198,7 +198,7 @@ subroutine define_cylindrical_grid() real(kind=dp), dimension(nz) :: dcos_theta real(kind=dp) :: r_i, r_f, dr, fac, r0, H, hzone real(kind=dp) :: delta_r, ln_delta_r, delta_r_in, ln_delta_r_in - real(kind=dp) :: theta, dtheta, delta_phi, Vi, dr2 + real(kind=dp) :: dtheta, delta_phi, Vi, dr2 integer :: ir, iz, n_cells_tmp, n_rad_region, n_rad_in_region, n_empty, istart, alloc_status, jc type(disk_zone_type) :: dz diff --git a/src/dust_transfer.f90 b/src/dust_transfer.f90 index bd43af35..aa6704ab 100644 --- a/src/dust_transfer.f90 +++ b/src/dust_transfer.f90 @@ -42,7 +42,6 @@ subroutine transfert_poussiere() ! Ajout du cas ou les matrices de Mueller sont donnees en entrees ! 20/04/2023 - use thermal_emission, only : frac_E_stars, frac_E_disk use MRW, only : initialize_cumulative_zeta use utils implicit none @@ -68,7 +67,7 @@ subroutine transfert_poussiere() real(kind=dp) :: x,y,z, u,v,w, lmin, lmax real :: rand, tau - integer :: i, icell, p_icell, n_SPH + integer :: i, icell, p_icell logical :: flag_star, flag_scatt, flag_ISM logical :: laffichage, flag_em_nRE, lcompute_dust_prop @@ -864,8 +863,7 @@ subroutine emit_packet(id,lambda, icell,x0,y0,z0,u0,v0,w0,stokes,flag_star,flag_ real :: rand, rand2, rand3, rand4 integer :: i_star - real(kind=dp) :: w02, srw02 - real :: argmt + real(kind=dp) :: w02 real :: hc_lk, correct_spot, cos_thet_spot, x_spot, y_spot, z_spot @@ -978,7 +976,7 @@ subroutine propagate_packet(id,lambda,p_lambda,icell,x,y,z,u,v,w,stokes,flag_sta logical, intent(out) :: flag_scatt real(kind=dp), dimension(4,4) :: M - real(kind=dp) :: u1,v1,w1, phi, cospsi, w02, srw02, argmt, Planck_opacity, rec_Planck_opacity, d, diff_coeff + real(kind=dp) :: u1,v1,w1, phi, cospsi, Planck_opacity, rec_Planck_opacity, d, diff_coeff integer :: taille_grain, itheta integer :: n_iteractions_in_cell, icell_old integer, pointer :: p_icell diff --git a/src/mol_transfer.f90 b/src/mol_transfer.f90 index 3bd49cee..4ad6f087 100644 --- a/src/mol_transfer.f90 +++ b/src/mol_transfer.f90 @@ -173,7 +173,7 @@ subroutine NLTE_mol_line_transfer(imol) real(kind=dp), dimension(nLevels,nb_proc) :: pop, pop_old - logical :: labs, laffichage + logical :: labs integer, dimension(2) :: ispeed real(kind=dp), dimension(:,:), allocatable :: tab_speed @@ -862,7 +862,7 @@ subroutine init_dust_mol(imol) integer, intent(in) :: imol - integer :: iTrans, p_lambda + integer :: iTrans integer, target :: icell integer, pointer :: p_icell real(kind=dp) :: freq!, Jnu @@ -886,7 +886,7 @@ subroutine init_dust_mol(imol) ! On n'est interesse que par les prop d'abs : pas besoin des matrices de mueller ! -> pas de polarisation, on utilise une HG - scattering_method=1 ; lscattering_method1 = .true. ; p_lambda = 1 + scattering_method=1 ; lscattering_method1 = .true. aniso_method = 2 ; lmethod_aniso1 = .false. lsepar_pola = .false. @@ -1102,7 +1102,7 @@ subroutine emission_line_tau_surface_map(imol,tau,ibin,iaz) real(kind=dp), dimension(3) :: uvw, x_plan_image, x, y_plan_image, center, dx, dy, Icorner real(kind=dp), dimension(3,nb_proc) :: pixelcenter - integer :: i,j, id, p_lambda, icell, iTrans + integer :: i,j, id, icell, iTrans real(kind=dp) :: l, taille_pix, x0, y0, z0, u0, v0, w0 logical :: lintersect, flag_star, flag_direct_star, flag_sortie, lpacket_alive integer, dimension(4) :: ispeed @@ -1211,8 +1211,8 @@ subroutine emission_line_energy_fraction_surface_map(imol,flux_fraction,ibin,iaz real(kind=dp), dimension(3) :: uvw, x_plan_image, x, y_plan_image, center, dx, dy, Icorner real(kind=dp), dimension(3,nb_proc) :: pixelcenter - integer :: i,j, id, p_lambda, icell, iTrans, iiTrans - real(kind=dp) :: l, taille_pix, x0, y0, z0, u0, v0, w0, Flux, pixelsize, factor + integer :: i,j, id, icell, iTrans, iiTrans + real(kind=dp) :: l, taille_pix, x0, y0, z0, u0, v0, w0, Flux, factor logical :: lintersect, flag_star, flag_direct_star, flag_sortie, lpacket_alive integer, dimension(4) :: ispeed diff --git a/src/optical_depth.f90 b/src/optical_depth.f90 index ae2f5365..7ed82208 100644 --- a/src/optical_depth.f90 +++ b/src/optical_depth.f90 @@ -617,7 +617,7 @@ subroutine physical_length_mol(imol,iTrans,icell_in,x,y,z,u,v,w, ispeed, tab_spe real(kind=dp), dimension(ispeed(1):ispeed(2)) :: P, tau_mol, dtau_mol, opacite real(kind=dp) :: tau_max, tau_previous, facteur_tau - integer :: i, iTrans, nbr_cell, next_cell, previous_cell, iv + integer :: iTrans, nbr_cell, next_cell, previous_cell, iv integer, target :: icell logical :: lcellule_non_vide, lstop @@ -745,7 +745,7 @@ subroutine physical_length_mol_Flux(imol,iTrans,icell_in,x,y,z,u,v,w, ispeed, ta real(kind=dp), dimension(ispeed(1):ispeed(2)) :: P, tau_mol, dtau_mol, opacite, I_mol, Snu, dI_mol real(kind=dp) :: I_max, I_previous - integer :: i, iTrans, nbr_cell, next_cell, previous_cell + integer :: iTrans, nbr_cell, next_cell, previous_cell integer, target :: icell logical :: lcellule_non_vide, lstop @@ -934,8 +934,8 @@ subroutine integ_tau_mol(imol) integer, intent(in) :: imol - real :: norme, norme1, vmax - integer :: i, j, iTrans, n_speed, icell, it + real :: norme + integer :: i, j, iTrans, icell, it integer, dimension(2) :: ispeed real(kind=dp), dimension(0:0) :: tab_speed, P @@ -1098,11 +1098,11 @@ subroutine integ_ray_atom(id,icell_in,x,y,z,u,v,w,iray,labs,N,lambda) logical, intent(in) :: labs integer, intent(in) :: N real(kind=dp), dimension(N), intent(in) :: lambda - real(kind=dp) :: x0, y0, z0, x1, y1, z1, l, l_contrib, l_void_before, Q, P(4) + real(kind=dp) :: x0, y0, z0, x1, y1, z1, l, l_contrib, l_void_before real(kind=dp), dimension(N) :: Snu, tau, dtau, chi, coronal_irrad integer, target :: icell integer, pointer :: p_icell - integer :: nbr_cell, next_cell, previous_cell, icell_star, i_star, la, icell_prev + integer :: nbr_cell, next_cell, previous_cell, icell_star, i_star, icell_prev logical :: lcellule_non_vide, lsubtract_avg, lintersect_stars x1=x;y1=y;z1=z @@ -1221,7 +1221,6 @@ subroutine physical_length_atom(id,icell_in,x,y,z,u,v,w,N,lambda,tau_threshold,f real(kind=dp) :: x0, y0, z0, x1, y1, z1, l, l_contrib, l_void_before, ltot(N) real(kind=dp), dimension(N) :: tau, dtau, chi, eta, tau_previous - real(kind=dp) :: tau_max, facteur_tau integer :: nbr_cell, next_cell, previous_cell, icell_star, i_star integer, target :: icell