Ignore:
Timestamp:
Jul 19, 2024, 4:15:44 PM (4 months ago)
Author:
abarral
Message:

Commit linked to correcting relevant warnings during gfortran compilation

[minor]
Correct remnants of fixed-form "+" in massbarxy.F90
Correct COMMON alignment in clesphys.h, flux_arp.h, cv*param.h, YOECUMF.h, alpale.h
Correct obsolete logical operators
Restrict use of iso_fortran_env in nf95_abort.f90
Remove redundant save in module declarations
Remove <continue> without labels
Fix nonstandard kind selectors

Location:
LMDZ6/branches/Amaury_dev/libf/phylmd/cospv2
Files:
6 edited

Legend:

Unmodified
Added
Removed
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cospv2/cosp_optics.F90

    r3491 r5081  
    7272    varOUT(1:dim1,1:dim2,1:dim3) = 0._wp
    7373    do j=1,dim2
    74        where(flag(:,j,:) .eq. 1)
     74       where(flag(:,j,:) == 1)
    7575          varOUT(:,j,:) = varIN2
    7676       endwhere
    77        where(flag(:,j,:) .eq. 2)
     77       where(flag(:,j,:) == 2)
    7878          varOUT(:,j,:) = varIN1
    7979       endwhere
     
    9696   
    9797    varOUT(1:dim1,1:dim2,1:dim3) = 0._wp
    98    where(flag(:,:,:) .eq. 1)
     98   where(flag(:,:,:) == 1)
    9999       varOUT(:,:,:) = varIN2
    100100    endwhere
    101     where(flag(:,:,:) .eq. 2)
     101    where(flag(:,:,:) == 2)
    102102       varOUT(:,:,:) = varIN1
    103103    endwhere
     
    295295
    296296    ! Which LIDAR frequency are we using?
    297     if (lidar_freq .eq. 355) then
     297    if (lidar_freq == 355) then
    298298       Cmol   = Cmol_355nm
    299299       rdiffm = rdiffm_355nm
    300300    endif
    301     if (lidar_freq .eq. 532) then
     301    if (lidar_freq == 532) then
    302302       Cmol   = Cmol_532nm
    303303       rdiffm = rdiffm_532nm
     
    336336   
    337337    ! LS and CONV Ice water coefficients
    338     if (ice_type .eq. 0) then
     338    if (ice_type == 0) then
    339339       polpart(INDX_LSICE,1:5) = polpartLSICE0
    340340       polpart(INDX_CVICE,1:5) = polpartCVICE0
    341341    endif
    342     if (ice_type .eq. 1) then
     342    if (ice_type == 1) then
    343343       polpart(INDX_LSICE,1:5) = polpartLSICE1
    344344       polpart(INDX_CVICE,1:5) = polpartCVICE1
     
    393393    ! Polynomials kp_lidar derived from Mie theory
    394394    do i = 1, npart
    395        where (rad_part(1:npoints,1:nlev,i) .gt. 0.0)
     395       where (rad_part(1:npoints,1:nlev,i) > 0.0)
    396396          kp_part(1:npoints,1:nlev,i) = &
    397397               polpart(i,1)*(rad_part(1:npoints,1:nlev,i)*1e6)**4 &
     
    426426       ! Alpha of particles in each subcolumn:
    427427       do i = 1, npart
    428           where (rad_part(1:npoints,1:nlev,i) .gt. 0.0)
     428          where (rad_part(1:npoints,1:nlev,i) > 0.0)
    429429             alpha_part(1:npoints,1:nlev,i) = 3._wp/4._wp * Qscat &
    430430                  * rhoair(1:npoints,1:nlev) * qpart(1:npoints,1:nlev,i) &
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cospv2/mrgrnk.F90

    r3491 r5081  
    6868       IRNGT (1) = 1
    6969       Return
    70     Case Default
    71        Continue
    7270    End Select
    7371    !
     
    268266       IRNGT (1) = 1
    269267       Return
    270     Case Default
    271        Continue
    272268    End Select
    273269    !
     
    467463       IRNGT (1) = 1
    468464       Return
    469     Case Default
    470        Continue
    471465    End Select
    472466    !
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cospv2/optics_lib.F90

    r3491 r5081  
    558558       if(tk < temref(4)) tk=temref(4)
    559559       do i=2,4
    560           if(tk.ge.temref(i)) go to 12
     560          if(tk>=temref(i)) go to 12
    561561       enddo
    56256212     lt1 = i
    563563       lt2 = i-1
    564564       do i=2,nwlt
    565           if(alam.le.wlt(i)) go to 14
     565          if(alam<=wlt(i)) go to 14
    566566       enddo
    56756714     x1  = log(wlt(i-1))
     
    652652    Complex(wp) :: A1
    653653   
    654     If ((Dx.Gt.Imaxx) .Or. (InP.Gt.ImaxNP)) Then
     654    If ((Dx>Imaxx) .Or. (InP>ImaxNP)) Then
    655655       Error = 1
    656656       Return
     
    659659    Ir = 1 / Cm
    660660    Y =  Dx * Cm
    661     If (Dx.Lt.0.02) Then
     661    If (Dx<0.02) Then
    662662       NStop = 2
    663663    Else
    664        If (Dx.Le.8.0) Then
     664       If (Dx<=8.0) Then
    665665          NStop = Dx + 4.00*Dx**(1./3.) + 2.0
    666666       Else
    667           If (Dx.Lt. 4200.0) Then
     667          If (Dx< 4200.0) Then
    668668             NStop = Dx + 4.05*Dx**(1./3.) + 2.0
    669669          Else
     
    673673    End If
    674674    NmX = Max(Real(NStop),Real(Abs(Y))) + 15.
    675     If (Nmx .gt. Itermax) then
     675    If (Nmx > Itermax) then
    676676       Error = 1
    677677       Return
     
    726726!ds       Dqxt = Tnp1 *      Dble(A + B)          + Dqxt
    727727       Dqsc = Tnp1 * (A*Conjg(A) + B*Conjg(B)) + Dqsc
    728        If (N.Gt.1) then
     728       If (N>1) then
    729729          Dg = Dg + (dN*dN - 1) * (ANM1*Conjg(A) + BNM1 * Conjg(B)) / dN + TNM1 *(ANM1*Conjg(BNM1)) / (dN*dN - dN)
    730730!ds          Dg = Dg + (dN*dN - 1) * Dble(ANM1*Conjg(A) + BNM1 * Conjg(B)) / dN + TNM1 * Dble(ANM1*Conjg(BNM1)) / (dN*dN - dN)
     
    735735       AMB = A2 * (A - B)
    736736       Do I = 1,Inp2
    737           If (I.GT.Inp) Then
     737          If (I>Inp) Then
    738738             S(I) = -Pi1(I)
    739739          Else
     
    756756    End Do
    757757
    758     If (Dg .GT.0) Dg = 2 * Dg / Dqsc
     758    If (Dg >0) Dg = 2 * Dg / Dqsc
    759759    Dqsc =  2 * Dqsc / Dx**2
    760760    Dqxt =  2 * Dqxt / Dx**2
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cospv2/quickbeam.F90

    r3491 r5081  
    179179         
    180180          ! Attenuation due to gaseous absorption between radar and volume
    181           if ((rcfg%use_gas_abs == 1) .or. (rcfg%use_gas_abs == 2 .and. pr .eq. 1)) then
     181          if ((rcfg%use_gas_abs == 1) .or. (rcfg%use_gas_abs == 2 .and. pr == 1)) then
    182182             if (d_gate==1) then
    183183                if (k>1) then
     
    272272
    273273    ! Which platforms to create diagnostics for?
    274     if (platform .eq. 'cloudsat') lcloudsat=.true.
     274    if (platform == 'cloudsat') lcloudsat=.true.
    275275
    276276    ! Create Cloudsat diagnostics.
     
    289289             enddo
    290290          enddo
    291           where(cfad_ze .ne. R_UNDEF) cfad_ze = cfad_ze/Ncolumns
     291          where(cfad_ze /= R_UNDEF) cfad_ze = cfad_ze/Ncolumns
    292292
    293293          ! Compute cloudsat near-surface precipitation diagnostics
     
    306306             enddo
    307307          enddo
    308           where(cfad_ze .ne. R_UNDEF) cfad_ze = cfad_ze/Ncolumns
     308          where(cfad_ze /= R_UNDEF) cfad_ze = cfad_ze/Ncolumns
    309309       endif
    310310    endif
     
    402402       do pr=1,Ncolumns
    403403          ! 1) Compute the PIA in all profiles containing hydrometeors
    404           if ( (Ze_non_out(i,pr,cloudsat_preclvl).gt.-100) .and. (Ze_out(i,pr,cloudsat_preclvl).gt.-100) ) then
    405              if ( (Ze_non_out(i,pr,cloudsat_preclvl).lt.100) .and. (Ze_out(i,pr,cloudsat_preclvl).lt.100) ) then
     404          if ( (Ze_non_out(i,pr,cloudsat_preclvl)>-100) .and. (Ze_out(i,pr,cloudsat_preclvl)>-100) ) then
     405             if ( (Ze_non_out(i,pr,cloudsat_preclvl)<100) .and. (Ze_out(i,pr,cloudsat_preclvl)<100) ) then
    406406                cloudsat_precip_pia(i,pr) = Ze_non_out(i,pr,cloudsat_preclvl) - Ze_out(i,pr,cloudsat_preclvl)
    407407             endif
     
    412412          ! 2a) Oceanic points.
    413413          ! ################################################################################
    414           if (land(i) .eq. 0) then
     414          if (land(i) == 0) then
    415415!             print*, 'aaa i, pr, fracPrecipIce(i,pr) : ', i, pr, fracPrecipIce(i,pr) !Artem
    416416             ! Snow
    417              if(fracPrecipIce(i,pr).gt.0.9) then
    418                 if(Ze_non_out(i,pr,cloudsat_preclvl).gt.Zenonbinval(2)) then
     417             if(fracPrecipIce(i,pr)>0.9) then
     418                if(Ze_non_out(i,pr,cloudsat_preclvl)>Zenonbinval(2)) then
    419419                   cloudsat_pflag(i,pr) = pClass_Snow2                   ! TSL: Snow certain
    420420                endif
    421                 if(Ze_non_out(i,pr,cloudsat_preclvl).gt.Zenonbinval(4).and. &
    422                      Ze_non_out(i,pr,cloudsat_preclvl).le.Zenonbinval(2)) then
     421                if(Ze_non_out(i,pr,cloudsat_preclvl)>Zenonbinval(4).and. &
     422                     Ze_non_out(i,pr,cloudsat_preclvl)<=Zenonbinval(2)) then
    423423                   cloudsat_pflag(i,pr) = pClass_Snow1                   ! TSL: Snow possible
    424424                endif
     
    426426             
    427427             ! Mixed
    428              if(fracPrecipIce(i,pr).gt.0.1.and.fracPrecipIce(i,pr).le.0.9) then
    429                 if(Ze_non_out(i,pr,cloudsat_preclvl).gt.Zenonbinval(2)) then
     428             if(fracPrecipIce(i,pr)>0.1.and.fracPrecipIce(i,pr)<=0.9) then
     429                if(Ze_non_out(i,pr,cloudsat_preclvl)>Zenonbinval(2)) then
    430430                   cloudsat_pflag(i,pr) = pClass_Mixed2                  ! TSL: Mixed certain
    431431                endif
    432                 if(Ze_non_out(i,pr,cloudsat_preclvl).gt.Zenonbinval(4).and. &
    433                      Ze_non_out(i,pr,cloudsat_preclvl).le.Zenonbinval(2)) then
     432                if(Ze_non_out(i,pr,cloudsat_preclvl)>Zenonbinval(4).and. &
     433                     Ze_non_out(i,pr,cloudsat_preclvl)<=Zenonbinval(2)) then
    434434                   cloudsat_pflag(i,pr) = pClass_Mixed1                  ! TSL: Mixed possible
    435435                endif
     
    437437             
    438438             ! Rain
    439              if(fracPrecipIce(i,pr).le.0.1) then
    440                 if(Ze_non_out(i,pr,cloudsat_preclvl).gt.Zenonbinval(1)) then
     439             if(fracPrecipIce(i,pr)<=0.1) then
     440                if(Ze_non_out(i,pr,cloudsat_preclvl)>Zenonbinval(1)) then
    441441                   cloudsat_pflag(i,pr) = pClass_Rain3                   ! TSL: Rain certain
    442442                endif
    443                 if(Ze_non_out(i,pr,cloudsat_preclvl).gt.Zenonbinval(3).and. &
    444                      Ze_non_out(i,pr,cloudsat_preclvl).le.Zenonbinval(1)) then
     443                if(Ze_non_out(i,pr,cloudsat_preclvl)>Zenonbinval(3).and. &
     444                     Ze_non_out(i,pr,cloudsat_preclvl)<=Zenonbinval(1)) then
    445445                   cloudsat_pflag(i,pr) = pClass_Rain2                   ! TSL: Rain probable
    446446                endif
    447                 if(Ze_non_out(i,pr,cloudsat_preclvl).gt.Zenonbinval(4).and. &
    448                      Ze_non_out(i,pr,cloudsat_preclvl).le.Zenonbinval(3)) then
     447                if(Ze_non_out(i,pr,cloudsat_preclvl)>Zenonbinval(4).and. &
     448                     Ze_non_out(i,pr,cloudsat_preclvl)<=Zenonbinval(3)) then
    449449                   cloudsat_pflag(i,pr) = pClass_Rain1                   ! TSL: Rain possible
    450450                endif
    451                 if(cloudsat_precip_pia(i,pr).gt.40) then
     451                if(cloudsat_precip_pia(i,pr)>40) then
    452452                   cloudsat_pflag(i,pr) = pClass_Rain4                   ! TSL: Heavy Rain
    453453                endif
     
    455455             
    456456             ! No precipitation
    457              if(Ze_non_out(i,pr,cloudsat_preclvl).le.-15) then
     457             if(Ze_non_out(i,pr,cloudsat_preclvl)<=-15) then
    458458                cloudsat_pflag(i,pr) = pClass_noPrecip                   ! TSL: Not Raining
    459459             endif
     
    463463          ! 2b) Land points.
    464464          ! ################################################################################
    465           if (land(i) .eq. 1) then
     465          if (land(i) == 1) then
    466466             ! Find Zmax, the maximum reflectivity value in the attenuated profile (Ze_out);
    467467             Zmax=maxval(Ze_out(i,pr,:))
    468468
    469469             ! Snow (T<273)
    470              if(t2m(i) .lt. 273._wp) then
    471                 if(Ze_out(i,pr,cloudsat_preclvl) .gt. Zbinvallnd(5)) then
     470             if(t2m(i) < 273._wp) then
     471                if(Ze_out(i,pr,cloudsat_preclvl) > Zbinvallnd(5)) then
    472472                   cloudsat_pflag(i,pr) = pClass_Snow2                      ! JEK: Snow certain
    473473                endif
    474                 if(Ze_out(i,pr,cloudsat_preclvl) .gt. Zbinvallnd(6) .and. &
    475                      Ze_out(i,pr,cloudsat_preclvl).le.Zbinvallnd(5)) then
     474                if(Ze_out(i,pr,cloudsat_preclvl) > Zbinvallnd(6) .and. &
     475                     Ze_out(i,pr,cloudsat_preclvl)<=Zbinvallnd(5)) then
    476476                   cloudsat_pflag(i,pr) = pClass_Snow1                      ! JEK: Snow possible
    477477                endif
     
    479479             
    480480             ! Mized phase (273<T<275)
    481              if(t2m(i) .ge. 273._wp .and. t2m(i) .le. 275._wp) then
    482                 if ((Zmax .gt. Zbinvallnd(1) .and. cloudsat_precip_pia(i,pr).gt.30) .or. &
    483                      (Ze_out(i,pr,cloudsat_preclvl) .gt. Zbinvallnd(4))) then
     481             if(t2m(i) >= 273._wp .and. t2m(i) <= 275._wp) then
     482                if ((Zmax > Zbinvallnd(1) .and. cloudsat_precip_pia(i,pr)>30) .or. &
     483                     (Ze_out(i,pr,cloudsat_preclvl) > Zbinvallnd(4))) then
    484484                   cloudsat_pflag(i,pr) = pClass_Mixed2                     ! JEK: Mixed certain
    485485                endif
    486                 if ((Ze_out(i,pr,cloudsat_preclvl) .gt. Zbinvallnd(6)  .and. &
    487                      Ze_out(i,pr,cloudsat_preclvl) .le. Zbinvallnd(4)) .and. &
    488                      (Zmax .gt. Zbinvallnd(5)) ) then
     486                if ((Ze_out(i,pr,cloudsat_preclvl) > Zbinvallnd(6)  .and. &
     487                     Ze_out(i,pr,cloudsat_preclvl) <= Zbinvallnd(4)) .and. &
     488                     (Zmax > Zbinvallnd(5)) ) then
    489489                   cloudsat_pflag(i,pr) = pClass_Mixed1                     ! JEK: Mixed possible
    490490                endif
     
    492492
    493493             ! Rain (T>275)
    494              if(t2m(i) .gt. 275) then
    495                 if ((Zmax .gt. Zbinvallnd(1) .and. cloudsat_precip_pia(i,pr).gt.30) .or. &
    496                      (Ze_out(i,pr,cloudsat_preclvl) .gt. Zbinvallnd(2))) then
     494             if(t2m(i) > 275) then
     495                if ((Zmax > Zbinvallnd(1) .and. cloudsat_precip_pia(i,pr)>30) .or. &
     496                     (Ze_out(i,pr,cloudsat_preclvl) > Zbinvallnd(2))) then
    497497                   cloudsat_pflag(i,pr) = pClass_Rain3                      ! JEK: Rain certain
    498498                endif
    499                 if((Ze_out(i,pr,cloudsat_preclvl) .gt. Zbinvallnd(6)) .and. &
    500                      (Zmax .gt. Zbinvallnd(3))) then
     499                if((Ze_out(i,pr,cloudsat_preclvl) > Zbinvallnd(6)) .and. &
     500                     (Zmax > Zbinvallnd(3))) then
    501501                   cloudsat_pflag(i,pr) = pClass_Rain2                      ! JEK: Rain probable
    502502                endif
    503                 if((Ze_out(i,pr,cloudsat_preclvl) .gt. Zbinvallnd(6)) .and. &
    504                      (Zmax.lt.Zbinvallnd(3))) then
     503                if((Ze_out(i,pr,cloudsat_preclvl) > Zbinvallnd(6)) .and. &
     504                     (Zmax<Zbinvallnd(3))) then
    505505                   cloudsat_pflag(i,pr) = pClass_Rain1                      ! JEK: Rain possible
    506506                endif
    507                 if(cloudsat_precip_pia(i,pr).gt.40) then
     507                if(cloudsat_precip_pia(i,pr)>40) then
    508508                   cloudsat_pflag(i,pr) = pClass_Rain4                      ! JEK: Heavy Rain
    509509                endif
     
    511511             
    512512             ! No precipitation
    513              if(Ze_out(i,pr,cloudsat_preclvl).le.-15) then
     513             if(Ze_out(i,pr,cloudsat_preclvl)<=-15) then
    514514                cloudsat_pflag(i,pr) =  pClass_noPrecip                     ! JEK: Not Precipitating
    515515             endif         
     
    526526       ! Gridmean precipitation fraction for each precipitation type
    527527       do k=1,nCloudsatPrecipClass
    528           if (any(cloudsat_pflag(i,:) .eq. k-1)) then
    529              cloudsat_precip_cover(i,k) = count(cloudsat_pflag(i,:) .eq. k-1)
     528          if (any(cloudsat_pflag(i,:) == k-1)) then
     529             cloudsat_precip_cover(i,k) = count(cloudsat_pflag(i,:) == k-1)
    530530          endif
    531531       enddo
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cospv2/quickbeam_optics.F90

    r3491 r5081  
    172172               
    173173                ! Compute effective radius from number concentration and distribution parameters
    174                 if (Re_internal .eq. 0) then
     174                if (Re_internal == 0) then
    175175                   call calc_Re(hm_matrix(pr,k,tp),Np_matrix(pr,k,tp),rho_a, &
    176176                        sd%dtype(tp),sd%apm(tp),sd%bpm(tp),sd%rho(tp),sd%p1(tp),sd%p2(tp),sd%p3(tp),Re)
     
    187187                ! Index into particle size dimension of scaling tables
    188188                iRe_type=1
    189                 if(Re.gt.0) then
     189                if(Re>0) then
    190190                   ! Determine index in to scale LUT
    191191                   ! Distance between Re points (defined by "base" and "step") for
     
    197197                   base = rcfg%base_list(n+1)
    198198                   iRe_type=Re/step
    199                    if (iRe_type.lt.1) iRe_type=1
     199                   if (iRe_type<1) iRe_type=1
    200200                   Re=step*(iRe_type+0.5_wp)    ! set value of Re to closest value allowed in LUT.
    201201                   iRe_type=iRe_type+base-int(n*Re_BIN_LENGTH/step)
    202202                   
    203203                   ! Make sure iRe_type is within bounds
    204                    if (iRe_type.ge.nRe_types) then
     204                   if (iRe_type>=nRe_types) then
    205205                      !write(*,*) 'Warning: size of Re exceed value permitted ', &
    206206                      !            'in Look-Up Table (LUT).  Will calculate. '
     
    405405    ! Exponential is same as modified gamma with vu =1
    406406    ! if Np is specified then we will just treat as modified gamma
    407     if(dtype .eq. 2 .and. Np .gt. 0) then
     407    if(dtype == 2 .and. Np > 0) then
    408408       local_dtype = 1
    409409       local_p3    = 1
     
    441441       endif
    442442       
    443        if( Np.eq.0 .and. p2+1 > 1E-8) then     ! use default value for MEAN diameter as first default 
     443       if( Np==0 .and. p2+1 > 1E-8) then     ! use default value for MEAN diameter as first default
    444444          dm = p2             ! by definition, should have units of microns
    445445          D0 = gamma(vu)/gamma(vu+1)*dm
    446446       else   ! use value of Np
    447           if(Np.eq.0) then
     447          if(Np==0) then
    448448             if( abs(p1+1) > 1E-8 ) then  !   use default number concentration   
    449449                local_Np = p1 ! total number concentration / pa --- units kg^-1
     
    525525       
    526526       ! get rg ...
    527        if( Np.eq.0 .and. (abs(p2+1) > 1E-8) ) then ! use default value of rg
     527       if( Np==0 .and. (abs(p2+1) > 1E-8) ) then ! use default value of rg
    528528          rg = p2     
    529529       else
     
    826826          log_sigma_g = p3
    827827          tmp2 = (bpm*log_sigma_g)*(bpm*log_sigma_g)
    828           if(Re.le.0) then
     828          if(Re<=0) then
    829829             rg = p2
    830830          else
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cospv2/scops.F90

    r3491 r5081  
    7575
    7676    ! Test for valid input overlap assumption
    77     if (overlap .ne. 1 .and. overlap .ne. 2 .and. overlap .ne. 3) then
     77    if (overlap /= 1 .and. overlap /= 2 .and. overlap /= 3) then
    7878       overlap=default_overlap
    7979       call errorMessage('ERROR(scops): Invalid overlap assumption provided. Using default overlap assumption (max/ran)')
     
    9292    tca(1:npoints,1:nlev) = cc(1:npoints,1:nlev)
    9393   
    94     if (ncolprint.ne.0) then
     94    if (ncolprint/=0) then
    9595       write (6,'(a)') 'frac_out_pp_rev:'
    9696       do j=1,npoints,1000
     
    102102       write (6,'(I3)') ncol
    103103    endif
    104     if (ncolprint.ne.0) then
     104    if (ncolprint/=0) then
    105105       write (6,'(a)') 'last_frac_pp:'
    106106       do j=1,npoints,1000
     
    122122       
    123123       ! Initialise threshold
    124        IF (ilev.eq.1) then
     124       IF (ilev==1) then
    125125          ! If max overlap
    126           IF (overlap.eq.1) then
     126          IF (overlap==1) then
    127127             ! Select pixels spread evenly across the gridbox
    128128             threshold(1:npoints,1:ncol)=boxpos(1:npoints,1:ncol)
     
    137137             enddo
    138138          ENDIF
    139           IF (ncolprint.ne.0) then
     139          IF (ncolprint/=0) then
    140140             write (6,'(a)') 'threshold_nsf2:'
    141141             do j=1,npoints,1000
     
    147147       ENDIF
    148148       
    149        IF (ncolprint.ne.0) then
     149       IF (ncolprint/=0) then
    150150          write (6,'(a)') 'ilev:'
    151151          write (6,'(I2)') ilev
     
    157157          !maxocc(1:npoints,ibox) = merge(1,0, conv(1:npoints,ilev) .gt. boxpos(1:npoints,ibox))
    158158          do j=1,npoints
    159              if (boxpos(j,ibox).le.conv(j,ilev)) then
     159             if (boxpos(j,ibox)<=conv(j,ilev)) then
    160160                maxocc(j,ibox) = 1
    161161             else
     
    165165         
    166166          ! Max overlap
    167           if (overlap.eq.1) then
     167          if (overlap==1) then
    168168             threshold_min(1:npoints,ibox) = conv(1:npoints,ilev)
    169169             maxosc(1:npoints,ibox)        = 1               
     
    171171         
    172172          ! Random overlap
    173           if (overlap.eq.2) then
     173          if (overlap==2) then
    174174             threshold_min(1:npoints,ibox) = conv(1:npoints,ilev)
    175175             maxosc(1:npoints,ibox)        = 0
    176176          endif
    177177          ! Max/Random overlap
    178           if (overlap.eq.3) then
     178          if (overlap==3) then
    179179             ! DS2014 START: The bounds on tca are not valid when ilev=1.
    180180             !threshold_min(1:npoints,ibox) = max(conv(1:npoints,ilev),min(tca(1:npoints,ilev-1),tca(1:npoints,ilev)))
     
    182182             !     min(tca(1:npoints,ilev-1),tca(1:npoints,ilev)) .and. &
    183183             !     (threshold(1:npoints,ibox).gt.conv(1:npoints,ilev)))
    184              if (ilev .ne. 1) then
     184             if (ilev /= 1) then
    185185                threshold_min(1:npoints,ibox) = max(conv(1:npoints,ilev),min(tca(1:npoints,ilev-1),tca(1:npoints,ilev)))
    186                 maxosc(1:npoints,ibox) = merge(1,0,threshold(1:npoints,ibox) .lt. &
     186                maxosc(1:npoints,ibox) = merge(1,0,threshold(1:npoints,ibox) < &
    187187                     min(tca(1:npoints,ilev-1),tca(1:npoints,ilev)) .and. &
    188                      (threshold(1:npoints,ibox).gt.conv(1:npoints,ilev)))
     188                     (threshold(1:npoints,ibox)>conv(1:npoints,ilev)))
    189189             else
    190190                threshold_min(1:npoints,ibox) = max(conv(1:npoints,ilev),min(0._wp,tca(1:npoints,ilev)))
    191                 maxosc(1:npoints,ibox) = merge(1,0,threshold(1:npoints,ibox) .lt. &
     191                maxosc(1:npoints,ibox) = merge(1,0,threshold(1:npoints,ibox) < &
    192192                     min(0._wp,tca(1:npoints,ilev)) .and. &
    193                      (threshold(1:npoints,ibox).gt.conv(1:npoints,ilev)))
     193                     (threshold(1:npoints,ibox)>conv(1:npoints,ilev)))
    194194             endif
    195195          endif
     
    205205         
    206206          ! Fill frac_out with 1's where tca is greater than the threshold
    207           frac_out(1:npoints,ibox,ilev) = merge(1,0,tca(1:npoints,ilev).gt.threshold(1:npoints,ibox))
     207          frac_out(1:npoints,ibox,ilev) = merge(1,0,tca(1:npoints,ilev)>threshold(1:npoints,ibox))
    208208         
    209209          ! Code to partition boxes into startiform and convective parts goes here
    210           where(threshold(1:npoints,ibox).le.conv(1:npoints,ilev) .and. conv(1:npoints,ilev).gt.0.) frac_out(1:npoints,ibox,ilev)=2
     210          where(threshold(1:npoints,ibox)<=conv(1:npoints,ilev) .and. conv(1:npoints,ilev)>0.) frac_out(1:npoints,ibox,ilev)=2
    211211       ENDDO ! ibox
    212212       
    213213       
    214214       ! Set last_frac to tca at this level, so as to be tca from last level next time round
    215        if (ncolprint.ne.0) then
     215       if (ncolprint/=0) then
    216216          do j=1,npoints ,1000
    217217             write(6,'(a10)') 'j='
Note: See TracChangeset for help on using the changeset viewer.