[cig-commits] [commit] devel: fixed all the warnings found by the new Intel compiler option -gen-interface -warn all (e76402e)

cig_noreply at geodynamics.org cig_noreply at geodynamics.org
Thu Mar 6 04:25:21 PST 2014


Repository : ssh://geoshell/specfem2d

On branch  : devel
Link       : https://github.com/geodynamics/specfem2d/compare/9fff280f4ba5985ff5c5f8cc3a13c01ebba67aa7...ab3e0a101b38a67315e3a1252a08266486fdee40

>---------------------------------------------------------------

commit e76402e6d40124ab4182cea7fb69782a751b81e1
Author: Dimitri Komatitsch <komatitsch at lma.cnrs-mrs.fr>
Date:   Thu Mar 6 13:23:13 2014 +0100

    fixed all the warnings found by the new Intel compiler option -gen-interface -warn all


>---------------------------------------------------------------

e76402e6d40124ab4182cea7fb69782a751b81e1
 flags.guess                                    |  2 +-
 src/specfem2D/compute_coupling_acoustic_el.f90 |  4 ++--
 src/specfem2D/compute_energy.f90               |  2 +-
 src/specfem2D/compute_forces_acoustic.f90      |  4 ++--
 src/specfem2D/compute_forces_poro_fluid.f90    | 23 ++++++++++++-----------
 src/specfem2D/compute_forces_poro_solid.f90    | 23 ++++++++++++-----------
 src/specfem2D/compute_forces_viscoelastic.F90  | 16 ++++++++++------
 src/specfem2D/compute_pressure.f90             |  4 ++--
 src/specfem2D/noise_tomography.f90             | 14 +++++++-------
 src/specfem2D/prepare_source_time_function.f90 |  2 +-
 src/specfem2D/specfem2D.F90                    | 12 ++++++------
 11 files changed, 56 insertions(+), 50 deletions(-)

diff --git a/flags.guess b/flags.guess
index c1bb871..bdc1aff 100644
--- a/flags.guess
+++ b/flags.guess
@@ -42,7 +42,7 @@ case $FC in
 # I/O throughput lingers at 2.5 MB/s, with it it can increase to ~44 MB/s
 # However it does not make much of a difference on NFS mounted volumes or with SFS 3.1.1 / Lustre 1.6.7.1 
         if test x"$FLAGS_CHECK" = x; then
-            FLAGS_CHECK="-O3 -check nobounds -xHost -ftz -assume buffered_io -assume byterecl -align sequence -vec-report0 -std03 -implicitnone -warn truncated_source -warn argument_checking -warn unused -warn declarations -warn alignments -warn ignore_loc -warn usage"
+            FLAGS_CHECK="-O3 -check nobounds -xHost -fpe0 -ftz -assume buffered_io -assume byterecl -align sequence -vec-report0 -std03 -implicitnone -gen-interface -warn all"
         fi
         # useful for debugging...
         # for debugging: change -O3 -check nobounds to      -check all -debug -g -O0 -fp-stack-check -traceback -ftrapuv
diff --git a/src/specfem2D/compute_coupling_acoustic_el.f90 b/src/specfem2D/compute_coupling_acoustic_el.f90
index 0be15f5..743a3d0 100644
--- a/src/specfem2D/compute_coupling_acoustic_el.f90
+++ b/src/specfem2D/compute_coupling_acoustic_el.f90
@@ -79,9 +79,9 @@
               ispec_PML,CPML_region_local,singularity_type_xz
    real(kind=CUSTOM_REAL) :: displ_x,displ_z,displ_n,&
                              xxi,zxi,xgamma,zgamma,jacobian1D,nx,nz,weight
-   real(kind=CUSTOM_REAL) :: time,deltat,kappa_x,kappa_z,d_x,d_z,alpha_x,alpha_z,beta_x,beta_z,&
+   real(kind=CUSTOM_REAL) :: kappa_x,kappa_z,d_x,d_z,alpha_x,alpha_z,beta_x,beta_z,&
                              A8,A9,A10,bb_xz_1,bb_xz_2,coef0_xz_1,coef1_xz_1,coef2_xz_1,coef0_xz_2,coef1_xz_2,coef2_xz_2
-
+   double precision :: time,deltat
 
       ! loop on all the coupling edges
       
diff --git a/src/specfem2D/compute_energy.f90 b/src/specfem2D/compute_energy.f90
index aae516c..d3d41e9 100644
--- a/src/specfem2D/compute_energy.f90
+++ b/src/specfem2D/compute_energy.f90
@@ -71,7 +71,7 @@
   real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLX) :: pressure_element
 
   real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLZ,nspec,N_SLS) :: e1,e11
-  double precision, dimension(NGLLX,NGLLZ,nspec) :: Mu_nu1,Mu_nu2
+  real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLZ,nspec) :: Mu_nu1,Mu_nu2
 
   integer :: nglob_acoustic
   real(kind=CUSTOM_REAL), dimension(nglob_acoustic) :: &
diff --git a/src/specfem2D/compute_forces_acoustic.f90 b/src/specfem2D/compute_forces_acoustic.f90
index aad4e08..a2ab4f0 100644
--- a/src/specfem2D/compute_forces_acoustic.f90
+++ b/src/specfem2D/compute_forces_acoustic.f90
@@ -245,7 +245,7 @@
             else
               stop 'only newmark and LDDRK have been implemented with PML'
             endif
-            ! the subroutine of lik_parameter_computation is presented at the end of compute_forces_viscoelastic.F90
+            ! the subroutine of lik_parameter_computation is located at the end of compute_forces_viscoelastic.F90
             call lik_parameter_computation(time_n,deltat,kappa_z,beta_z,alpha_z,kappa_x,beta_x,alpha_x,&
                                            CPML_region_local,31,A5,A6,A7,singularity_type_zx,bb_zx_1,bb_zx_2,&
                                            coef0_zx_1,coef1_zx_1,coef2_zx_1,coef0_zx_2,coef1_zx_2,coef2_zx_2)
@@ -377,7 +377,7 @@
             alpha_z = alpha_z_store(i,j,ispec_PML)
             beta_x = alpha_x + d_x / kappa_x
             beta_z = alpha_z + d_z / kappa_z
-            ! the subroutine of l_parameter_computation is presented at the end of compute_forces_viscoelastic.F90
+            ! the subroutine of l_parameter_computation is located at the end of compute_forces_viscoelastic.F90
             call l_parameter_computation(time_n,deltat,kappa_x,beta_x,alpha_x,kappa_z,beta_z,alpha_z, &
                                          CPML_region_local,A0,A1,A2,A3,A4,singularity_type,&
                                          bb_1,coef0_1,coef1_1,coef2_1,bb_2,coef0_2,coef1_2,coef2_2)
diff --git a/src/specfem2D/compute_forces_poro_fluid.f90 b/src/specfem2D/compute_forces_poro_fluid.f90
index 67f471d..cc50e33 100644
--- a/src/specfem2D/compute_forces_poro_fluid.f90
+++ b/src/specfem2D/compute_forces_poro_fluid.f90
@@ -115,8 +115,8 @@
   real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLZ,nspec,N_SLS) :: e11_LDDRK,e13_LDDRK
   real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLZ,nspec,N_SLS) :: e11_initial_rk,e13_initial_rk
   real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLZ,nspec,N_SLS,stage_time_scheme) :: e11_force_RK, e13_force_RK
-  double precision, dimension(NGLLX,NGLLZ,nspec,N_SLS) :: inv_tau_sigma_nu2,phi_nu2
-  double precision, dimension(NGLLX,NGLLZ,nspec) :: Mu_nu2
+  real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLZ,nspec,N_SLS) :: inv_tau_sigma_nu2,phi_nu2
+  real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLZ,nspec) :: Mu_nu2
   real(kind=CUSTOM_REAL) :: e11_sum,e13_sum
   integer :: i_sls
 
@@ -141,10 +141,10 @@
 
   double precision :: f0,freq0,Q0,w_c
 
-  ! Parameter for LDDRK time scheme
-  double precision, dimension(Nstages) :: alpha_LDDRK,beta_LDDRK
+  ! parameters for the LDDRK time scheme
+  real(kind=CUSTOM_REAL), dimension(Nstages) :: alpha_LDDRK,beta_LDDRK
 
-  !temp variable
+  ! temporary variable
   real(kind=CUSTOM_REAL) :: weight_rk
 
 
@@ -180,14 +180,15 @@
 
 ! material properties of the poroelastic medium
   real(kind=CUSTOM_REAL) :: mul_relaxed_viscoelastic,lambdal_relaxed_viscoelastic,lambdalplus2mul_relaxed_viscoel
-  real(kind=CUSTOM_REAL) :: mul_s,kappal_s,rhol_s
-  real(kind=CUSTOM_REAL) :: etal_f,kappal_f,rhol_f
-  real(kind=CUSTOM_REAL) :: mul_fr,kappal_fr,phil,tortl,viscodampx,viscodampz
-  real(kind=CUSTOM_REAL) :: permlxx,permlxz,permlzz,invpermlxx,invpermlxz,invpermlzz,detk
-  real(kind=CUSTOM_REAL) :: D_biot,H_biot,C_biot,M_biot,rhol_bar
+  double precision :: mul_s,kappal_s,rhol_s
+  double precision :: etal_f,kappal_f,rhol_f
+  double precision :: mul_fr,kappal_fr,phil,tortl,viscodampx,viscodampz
+  double precision :: permlxx,permlxz,permlzz,invpermlxx,invpermlxz,invpermlzz,detk
+  double precision :: D_biot,H_biot,C_biot,M_biot,rhol_bar
 
   real(kind=CUSTOM_REAL) :: mul_G,lambdal_G,lambdalplus2mul_G
-  real(kind=CUSTOM_REAL) :: cpIsquare,cpIIsquare,cssquare,cpIl,cpIIl,csl
+  real(kind=CUSTOM_REAL) :: cpIl,cpIIl,csl
+  double precision :: cpIsquare,cpIIsquare,cssquare
 
 ! for attenuation
   real(kind=CUSTOM_REAL) :: phinu2,tauinvnu2,theta_n_u,theta_nsub1_u
diff --git a/src/specfem2D/compute_forces_poro_solid.f90 b/src/specfem2D/compute_forces_poro_solid.f90
index 9365cf4..9e92775 100644
--- a/src/specfem2D/compute_forces_poro_solid.f90
+++ b/src/specfem2D/compute_forces_poro_solid.f90
@@ -116,8 +116,8 @@
   real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLZ,nspec,N_SLS) :: e11_LDDRK,e13_LDDRK
   real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLZ,nspec,N_SLS) :: e11_initial_rk,e13_initial_rk
   real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLZ,nspec,N_SLS,stage_time_scheme) :: e11_force_RK, e13_force_RK
-  double precision, dimension(NGLLX,NGLLZ,nspec,N_SLS) :: inv_tau_sigma_nu2,phi_nu2
-  double precision, dimension(NGLLX,NGLLZ,nspec) :: Mu_nu2
+  real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLZ,nspec,N_SLS) :: inv_tau_sigma_nu2,phi_nu2
+  real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLZ,nspec) :: Mu_nu2
   real(kind=CUSTOM_REAL) :: e11_sum,e13_sum
   integer :: i_sls
 
@@ -143,10 +143,10 @@
 !
   double precision :: f0,freq0,Q0,w_c
 
-! Parameter for LDDRK time scheme
-  double precision, dimension(Nstages) :: alpha_LDDRK,beta_LDDRK
+! parameters for the LDDRK time scheme
+  real(kind=CUSTOM_REAL), dimension(Nstages) :: alpha_LDDRK,beta_LDDRK
 
-!temp variable
+! temporary variable
   real(kind=CUSTOM_REAL) :: weight_rk
 
 !---
@@ -184,14 +184,15 @@
 
 ! material properties of the poroelastic medium
   real(kind=CUSTOM_REAL) :: mul_relaxed_viscoelastic,lambdal_relaxed_viscoelastic,lambdalplus2mul_relaxed_viscoel
-  real(kind=CUSTOM_REAL) :: mul_s,kappal_s,rhol_s
-  real(kind=CUSTOM_REAL) :: etal_f,kappal_f,rhol_f
-  real(kind=CUSTOM_REAL) :: mul_fr,kappal_fr,phil,tortl,viscodampx,viscodampz
-  real(kind=CUSTOM_REAL) :: permlxx,permlxz,permlzz,invpermlxx,invpermlxz,invpermlzz,detk
-  real(kind=CUSTOM_REAL) :: D_biot,H_biot,C_biot,M_biot,rhol_bar
+  double precision :: mul_s,kappal_s,rhol_s
+  double precision :: etal_f,kappal_f,rhol_f
+  double precision :: mul_fr,kappal_fr,phil,tortl,viscodampx,viscodampz
+  double precision :: permlxx,permlxz,permlzz,invpermlxx,invpermlxz,invpermlzz,detk
+  double precision :: D_biot,H_biot,C_biot,M_biot,rhol_bar
 
   real(kind=CUSTOM_REAL) :: mul_G,lambdal_G,lambdalplus2mul_G
-  real(kind=CUSTOM_REAL) :: cpIsquare,cpIIsquare,cssquare,cpIl,cpIIl,csl
+  real(kind=CUSTOM_REAL) :: cpIl,cpIIl,csl
+  double precision :: cpIsquare,cpIIsquare,cssquare
 
 ! for attenuation
   real(kind=CUSTOM_REAL) :: phinu2,tauinvnu2,theta_n_u,theta_nsub1_u
diff --git a/src/specfem2D/compute_forces_viscoelastic.F90 b/src/specfem2D/compute_forces_viscoelastic.F90
index ad56a3d..8d76d79 100644
--- a/src/specfem2D/compute_forces_viscoelastic.F90
+++ b/src/specfem2D/compute_forces_viscoelastic.F90
@@ -92,7 +92,7 @@ subroutine compute_forces_viscoelastic(p_sv,nglob,nspec,myrank,nelemabs,numat, &
   logical :: anyabs,assign_external_model,initialfield,ATTENUATION_VISCOELASTIC_SOLID,add_Bielak_conditions,&
              STACEY_BOUNDARY_CONDITIONS
   logical :: ADD_SPRING_TO_STACEY
-  real(kind=CUSTOM_REAL) :: x_center_spring,z_center_spring
+  double precision :: x_center_spring,z_center_spring
 
   logical :: SAVE_FORWARD
 
@@ -223,10 +223,11 @@ subroutine compute_forces_viscoelastic(p_sv,nglob,nspec,myrank,nelemabs,numat, &
   real(kind=CUSTOM_REAL) :: dux_dxi_old,dux_dgamma_old,duz_dxi_old,duz_dgamma_old
   logical :: backward_simulation
 
-  real(kind=CUSTOM_REAL) :: kappa_x,kappa_z,d_x,d_z,alpha_x,alpha_z,beta_x,beta_z,time_n,time_nsub1,&                            
+  real(kind=CUSTOM_REAL) :: kappa_x,kappa_z,d_x,d_z,alpha_x,alpha_z,beta_x,beta_z, &                            
                             A5,A6,A7, bb_zx_1,bb_zx_2,coef0_zx_1,coef1_zx_1,coef2_zx_1,coef0_zx_2,coef1_zx_2,coef2_zx_2,&
                             A8,A9,A10,bb_xz_1,bb_xz_2,coef0_xz_1,coef1_xz_1,coef2_xz_1,coef0_xz_2,coef1_xz_2,coef2_xz_2,&
                             A0,A1,A2,A3,A4,bb_1,coef0_1,coef1_1,coef2_1,bb_2,coef0_2,coef1_2,coef2_2
+  double precision :: time_n,time_nsub1
   integer :: CPML_region_local,singularity_type_zx,singularity_type_xz,singularity_type
 
 !!!update momeory variable in viscoelastic simulation
@@ -1628,6 +1629,7 @@ end subroutine compute_forces_viscoelastic
  end subroutine compute_forces_viscoelastic_pre_kernel
 
 !========================================================================
+
  subroutine compute_coef_convolution(bb,deltat,coef0,coef1,coef2)
   ! compute coefficient used in second order convolution scheme, from
   ! second-order accurate convolution term calculation from equation (21) of
@@ -1652,15 +1654,16 @@ end subroutine compute_forces_viscoelastic
    endif
 
  end subroutine compute_coef_convolution
+
 !========================================================================
+
  subroutine lik_parameter_computation(time,deltat,kappa_x,beta_x,alpha_x,kappa_z,beta_z,alpha_z, &
                                      CPML_region_local,index_ik,A_0,A_1,A_2,singularity_type_2,bb_1,bb_2, &
                                      coef0_1,coef1_1,coef2_1,coef0_2,coef1_2,coef2_2)
   implicit none
   include "constants.h"
 
-  real(kind=CUSTOM_REAL), intent(in) :: time
-  double precision :: deltat
+  double precision, intent(in) :: time, deltat
   real(kind=CUSTOM_REAL), intent(in) :: kappa_x,beta_x,alpha_x,kappa_z,beta_z,alpha_z
   integer, intent(in) :: CPML_region_local,index_ik
 
@@ -1752,7 +1755,9 @@ end subroutine compute_forces_viscoelastic
   call compute_coef_convolution(bb_2,deltat,coef0_2,coef1_2,coef2_2)
 
  end subroutine lik_parameter_computation
+
 !========================================================================
+
  subroutine l_parameter_computation(time,deltat,kappa_x,beta_x,alpha_x,kappa_z,beta_z,alpha_z, &
                                     CPML_region_local,A_0,A_1,A_2,A_3,A_4,singularity_type,&
                                     bb_1,coef0_1,coef1_1,coef2_1,bb_2,coef0_2,coef1_2,coef2_2)
@@ -1760,8 +1765,7 @@ end subroutine compute_forces_viscoelastic
   implicit none
   include "constants.h"
 
-  real(kind=CUSTOM_REAL), intent(in) :: time
-  double precision :: deltat
+  double precision, intent(in) :: time, deltat
   real(kind=CUSTOM_REAL), intent(in) :: kappa_x,beta_x,alpha_x,kappa_z,beta_z,alpha_z
   integer, intent(in) :: CPML_region_local
 
diff --git a/src/specfem2D/compute_pressure.f90 b/src/specfem2D/compute_pressure.f90
index 69240ea..96d72f6 100644
--- a/src/specfem2D/compute_pressure.f90
+++ b/src/specfem2D/compute_pressure.f90
@@ -89,7 +89,7 @@
 
   integer :: N_SLS
   real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLZ,nspec,N_SLS) :: e1,e11
-  double precision, dimension(NGLLX,NGLLZ,nspec) :: Mu_nu1,Mu_nu2
+  real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLZ,nspec) :: Mu_nu1,Mu_nu2
 
 ! local variables
   integer :: i,j,ispec,iglob
@@ -173,7 +173,7 @@
   integer :: N_SLS
   real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLZ,nspec,N_SLS) :: e1,e11
   real(kind=CUSTOM_REAL) :: e1_sum,e11_sum
-  double precision, dimension(NGLLX,NGLLZ,nspec) :: Mu_nu1,Mu_nu2
+  real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLZ,nspec) :: Mu_nu1,Mu_nu2
   integer :: i_sls
 
 ! local variables
diff --git a/src/specfem2D/noise_tomography.f90 b/src/specfem2D/noise_tomography.f90
index 67e7562..322e41d 100644
--- a/src/specfem2D/noise_tomography.f90
+++ b/src/specfem2D/noise_tomography.f90
@@ -57,7 +57,7 @@
 
   !input
   integer :: nglob
-  real(kind=CUSTOM_REAL), dimension(2,nglob) :: coord
+  double precision, dimension(2,nglob) :: coord
 
   !output
   real(kind=CUSTOM_REAL), dimension(nglob) :: mask_noise
@@ -174,7 +174,7 @@
   logical :: p_sv
   integer NSTEP, ispec_noise,nglob
   integer, dimension(NGLLX,NGLLZ,nglob) :: ibool
-  real(kind=CUSTOM_REAL) :: deltat, xi_noise, gamma_noise
+  double precision :: deltat, xi_noise, gamma_noise
 
   !output
   real(kind=CUSTOM_REAL), dimension(NSTEP) :: time_function_noise
@@ -183,10 +183,10 @@
   !local
   integer :: it,i,j,iglob
   real(kind=CUSTOM_REAL) :: t
-  real(kind=CUSTOM_REAL), dimension(NGLLX) :: xigll
-  real(kind=CUSTOM_REAL), dimension(NGLLZ) :: zigll
-  real(kind=CUSTOM_REAL), dimension(NGLLX) :: hxi, hpxi
-  real(kind=CUSTOM_REAL), dimension(NGLLZ) :: hgamma, hpgamma
+  double precision, dimension(NGLLX) :: xigll
+  double precision, dimension(NGLLZ) :: zigll
+  double precision, dimension(NGLLX) :: hxi, hpxi
+  double precision, dimension(NGLLZ) :: hgamma, hpgamma
   real(kind=CUSTOM_REAL) :: factor_noise, aval, t0
 
 ! ---------------------------------------------------------------------------------
@@ -312,7 +312,7 @@
   integer :: ispec_noise, nglob
   integer, dimension(NGLLX,NGLLZ,nglob) :: ibool
   real(kind=CUSTOM_REAL), dimension(3,nglob) :: accel_elastic
-  real(kind=CUSTOM_REAL) :: angle_noise
+  double precision :: angle_noise
   real(kind=CUSTOM_REAL), dimension(3,NGLLX,NGLLZ,NSTEP) :: source_array_noise
 
   !local
diff --git a/src/specfem2D/prepare_source_time_function.f90 b/src/specfem2D/prepare_source_time_function.f90
index 5f99866..e1c53f4 100644
--- a/src/specfem2D/prepare_source_time_function.f90
+++ b/src/specfem2D/prepare_source_time_function.f90
@@ -63,7 +63,7 @@
   integer,dimension(NSOURCES) :: nb_proc_source
   double precision :: deltat
   integer :: stage_time_scheme
-  double precision, dimension(Nstages) :: c_LDDRK
+  real(kind=CUSTOM_REAL), dimension(Nstages) :: c_LDDRK
 
   real(kind=CUSTOM_REAL),dimension(NSOURCES,NSTEP,stage_time_scheme) :: source_time_function
 
diff --git a/src/specfem2D/specfem2D.F90 b/src/specfem2D/specfem2D.F90
index 6f3dda1..50fdf94 100644
--- a/src/specfem2D/specfem2D.F90
+++ b/src/specfem2D/specfem2D.F90
@@ -528,11 +528,11 @@
     rmass_s_inverse_poroelastic,rmass_w_inverse_poroelastic
 
 ! to evaluate cpI, cpII, and cs, and rI (poroelastic medium)
-  real(kind=CUSTOM_REAL) :: rhol_s,rhol_f,rhol_bar,phil,tortl
-  real(kind=CUSTOM_REAL) :: mul_s,kappal_s
-  real(kind=CUSTOM_REAL) :: kappal_f
-  real(kind=CUSTOM_REAL) :: mul_fr,kappal_fr
-  real(kind=CUSTOM_REAL) :: D_biot,H_biot,C_biot,M_biot,B_biot,cpIsquare,cpIIsquare,cssquare
+  double precision :: rhol_s,rhol_f,rhol_bar,phil,tortl
+  double precision :: mul_s,kappal_s
+  double precision :: kappal_f
+  double precision :: mul_fr,kappal_fr
+  double precision :: D_biot,H_biot,C_biot,M_biot,B_biot,cpIsquare,cpIIsquare,cssquare
   real(kind=CUSTOM_REAL) :: ratio,dd1
 
   double precision, dimension(:,:,:), allocatable :: vpext,vsext,rhoext
@@ -941,7 +941,7 @@
 
   integer :: NOISE_TOMOGRAPHY
   integer :: irec_master, ispec_noise
-  real(kind=CUSTOM_REAL) :: xi_noise, gamma_noise, angle_noise
+  double precision :: xi_noise, gamma_noise, angle_noise
   real(kind=CUSTOM_REAL), dimension(:), allocatable :: time_function_noise
   real(kind=CUSTOM_REAL), dimension(:,:,:,:), allocatable :: source_array_noise
   real(kind=CUSTOM_REAL), dimension(:), allocatable :: mask_noise



More information about the CIG-COMMITS mailing list