Ignore:
Timestamp:
Jul 19, 2024, 5:41:58 PM (13 months ago)
Author:
abarral
Message:

(lint) Fix obsolete boolean operators

Location:
LMDZ6/branches/Amaury_dev/libf/phylmd/Dust
Files:
23 edited

Legend:

Unmodified
Added
Removed
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/aeropt_spl.F

    r4593 r5082  
    130130      rh=MIN(RHcl(i,k)*100.,RH_MAX)
    131131      RH_num = INT( rh/10. + 1.)
    132       IF (rh.gt.85.) RH_num=10
    133       IF (rh.gt.90.) RH_num=11
     132      IF (rh>85.) RH_num=10
     133      IF (rh>90.) RH_num=11
    134134c      IF (rh.gt.40.) THEN
    135135c          RH_num=5   ! Added by NHL temporarily
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/checknanqfi.F90

    r2630 r5082  
    2121        ENDIF
    2222     ENDDO
    23      IF (jbad.GT.0) THEN
     23     IF (jbad>0) THEN
    2424        WRITE(*,*)comment
    2525        DO i = 1, jbad
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/coarsemission.F

    r4593 r5082  
    197197     
    198198      DO i=1,klon   
    199          if (maskd(i).gt.0) then
     199         if (maskd(i)>0) then
    200200      IF(id_fine>0)    source_tr(i,id_fine)=
    201201     . scale_param_dustacc(iregion_dust(i))*
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/dustemission_mod.F90

    r3806 r5082  
    482482! 1440 = 15 days
    483483! 480 = 5 days
    484 if (MOD(counter,1440).eq. 0) THEN
     484if (MOD(counter,1440)== 0) THEN
    485485   !if (MOD(counter,480).eq. 0) THEN
    486486   do k = 1,klon
     
    760760         dp=dp*exp(dstep)
    761761         sizeclass(i)=dp
    762          if(dp.ge.dmax+eps)goto 30
     762         if(dp>=dmax+eps)goto 30
    763763         newstep(i)=dstep
    764764        ! WRITE(18,*)i,sizeclass(i)
     
    769769      print*,'   soil size classes used   ',ncl,' / ',nclass
    770770      print*,'   soil size min: ',sizeclass(1),' soil size max: ',sizeclass(ncl)
    771       if(ncl.gt.nclass)stop
     771      if(ncl>nclass)stop
    772772
    773773! Threshold velocity:
     
    780780            cc=sqrt(1+ddust*(sizeclass(i)**(-2.5)))
    781781            xk=sqrt(abs(rop*gravity*sizeclass(i)/roa))
    782             if (bb.lt.10.) then
     782            if (bb<10.) then
    783783               dd=sqrt(1.928*(bb**0.092)-1.)
    784784               uth(i)=0.129*xk*cc/dd
     
    817817           nsi=((j-1)*3)+2
    818818           npi=((j-1)*3)+3
    819            IF (solspe(ns,nd).EQ.0.)THEN
     819           IF (solspe(ns,nd)==0.)THEN
    820820              su_loc=0.
    821821           ELSE
     
    833833     END DO
    834834     DO i=1,ncl
    835         IF (subsoildist(i).gt.0..and.stotale.gt.0.)THEN
     835        IF (subsoildist(i)>0..and.stotale>0.)THEN
    836836            srel(ns,i)=subsoildist(i)/stotale
    837837
     
    854854          do k=1,ntyp
    855855     !     print*,'IKKK ',i,klon,k,ntyp
    856              if (zos(i,k).eq.0..or.z01(i,k).eq.0.) then
     856             if (zos(i,k)==0..or.z01(i,k)==0.) then
    857857     !       if (zos(i,k)<=0..or.z01(i,k)<=0.) then
    858858!              if (zos(i,k)<0..or.z01(i,k)<0.) then
     
    873873! drag partition between zo1 and zo2
    874874! feff: total efficient fraction
    875               if(D(i,k).eq.0.)then
     875              if(D(i,k)==0.)then
    876876                 feff(i,k)=cc
    877877   !       print*,'IKKK C ',i,klon,k,ntyp
     
    882882   !       print*,'IKKK D ',i,klon,k,ntyp
    883883              endif
    884               if (feff(i,k).lt.0.)feff(i,k)=0.
    885               if (feffdbg(i,k).lt.0.)feffdbg(i,k)=0.
    886               if (feff(i,k).gt.1.)feff(i,k)=1.
    887               if (feffdbg(i,k).gt.1.)feffdbg(i,k)=1.
     884              if (feff(i,k)<0.)feff(i,k)=0.
     885              if (feffdbg(i,k)<0.)feffdbg(i,k)=0.
     886              if (feff(i,k)>1.)feff(i,k)=1.
     887              if (feffdbg(i,k)>1.)feffdbg(i,k)=1.
    888888    !      print*,'IKKK E ',i,klon,k,ntyp
    889889            endif
     
    891891        enddo
    892892! JE20150120<<
    893   if (flag_feff .eq. 0) then
     893  if (flag_feff == 0) then
    894894    print *,'JE_dbg FORCED deactivated feff'
    895895    do i=1,klon
     
    12081208                         - 0.5*log(auxreal/(2.*pi))+1./(12.*auxreal) &
    12091209                         -1./(360.*(auxreal**3.))+1./(1260.*(auxreal**5.)))
    1210                 IF(nwb.gt.1)THEN
     1210                IF(nwb>1)THEN
    12111211                   wind10ms(kwb)=kwb*2.*U10mMOD/nwb
    12121212!original
     
    12201220                   probu(kwb)=pdfu*2.*U10mMOD/nwb
    12211221                   pdfcum=pdfcum+probu(kwb)
    1222                       IF(probu(kwb).le.1.e-2)GOTO 70
     1222                      IF(probu(kwb)<=1.e-2)GOTO 70
    12231223                ELSE
    12241224                   wind10ms(kwb)=U10mMOD
     
    12351235!                  nat=int(sol(i,n))
    12361236!                    print *,i,n
    1237                     IF(sol(i,n).gt.1..and.sol(i,n).lt.15.) nat=int(sol(i,n))
     1237                    IF(sol(i,n)>1..and.sol(i,n)<15.) nat=int(sol(i,n))
    12381238!JE20140526<<
    12391239!                    print *,'JE: WARNING: nat=0 forced to nat=99!! and doing nothing'
    1240                    IF(sol(i,n).lt.0.5) THEN
     1240                   IF(sol(i,n)<0.5) THEN
    12411241                      nat=99
    12421242                      GOTO 80
     
    12471247                 !IF(n.eq.1.and.nat.eq.99)GOTO 80
    12481248             !      if(n.eq.1) print*,'nat1=',nat,'sol1=',sol(i,n)
    1249                    IF(n.eq.1.and.nat.eq.99)GOTO 80
     1249                   IF(n==1.and.nat==99)GOTO 80
    12501250
    12511251             ENDIF
     
    12611261                      cpcent=P(i,n)
    12621262                      ustarsalt=0.
    1263                    IF(ceff.le.0..or.z0salt.eq.0.)GOTO 80
    1264                    IF(cerod.eq.0.or.cpcent.eq.0.)GOTO 80
     1263                   IF(ceff<=0..or.z0salt==0.)GOTO 80
     1264                   IF(cerod==0.or.cpcent==0.)GOTO 80
    12651265! in cm: utmin, umin, z10m, z0salt, ustarns
    12661266! in meters: modwm
     
    12731273
    12741274
    1275                    IF(ustarsalt.lt.umin/ceff)GOTO 80
     1275                   IF(ustarsalt<umin/ceff)GOTO 80
    12761276!                      print*,'ustarsalt = ',ustarsalt
    12771277!----------------------------------------
     
    12811281      do ni=1,kfin
    12821282         fdp1=1.-(uth2(ni)/(ceff*ustarsalt))
    1283          if (fdp1.le.0..or.srel2(nat,ni).eq.0.) then
     1283         if (fdp1<=0..or.srel2(nat,ni)==0.) then
    12841284            ad1=0.
    12851285            ad2=0.
     
    12971297            t2=0.
    12981298            t3=0.
    1299             if(ec.ge.e1)t1=1.
    1300             if(ec.ge.e2)t2=1.
    1301             if(ec.ge.e3)t3=1.
    1302             if(dfec3.ne.0.)then
     1299            if(ec>=e1)t1=1.
     1300            if(ec>=e2)t2=1.
     1301            if(ec>=e3)t3=1.
     1302            if(dfec3/=0.)then
    13031303               p1=t1*dfec1/dfec3
    13041304               p2=t2*(1.-p1)*dfec2/dfec3
     
    14091409            srel2(nat,kfin)=srel(nat,i)*istep
    14101410         enddo
    1411          if(kfin.ge.nclass)then
     1411         if(kfin>=nclass)then
    14121412            print*,'$$$$ Tables dimension problem:',kfin,'>',nclass
    14131413         endif
     
    14401440      ihalf=int((ismax+ismin)/2.)
    14411441      do k2=1,1000000
    1442           if(ds.gt.siz(ihalf))then
     1442          if(ds>siz(ihalf))then
    14431443             ismin=ihalf
    14441444          else
     
    14471447          ihalf=int((ismax+ismin)/2.)
    14481448          idiff=ismax-ismin
    1449           if(idiff.le.1)then
     1449          if(idiff<=1)then
    14501450             iout=ismin
    14511451             goto 52
     
    14531453      enddo
    14541454 52   continue
    1455       if(iout.eq.0)then
     1455      if(iout==0)then
    14561456        print*,'$$$$ Tables dimension problem: ',iout
    14571457      endif
     
    15191519       diffmol1(nb)=dmn1*(1.+dmn2+dmn3)
    15201520       diffmol2(nb)=bolz*temp*Cc/(3.*pi*muair*binsHRcm(nb))
    1521        IF(idiffusi.EQ.1)diffmole(nb)=diffmol1(nb)
    1522        IF(idiffusi.EQ.2)diffmole(nb)=diffmol2(nb)
     1521       IF(idiffusi==1)diffmole(nb)=diffmol1(nb)
     1522       IF(idiffusi==2)diffmole(nb)=diffmol2(nb)
    15231523       schmidtnumb(nb)=nuair/diffmole(nb)
    15241524       St=setvel(nb)*ustarbin*ustarbin/(gravity*nuair)
    15251525       rb=1./(ustarbin*((schmidtnumb(nb))**(-2./3.)+10.**(-3./St)))
    15261526!c wesely (primarily designed for gases)
    1527        IF(idrydep.EQ.1)THEN
     1527       IF(idrydep==1)THEN
    15281528          vdout(nb)=1./(ra+rb+ra*rb*setvel(nb))+setvel(nb)
    15291529       END IF
    15301530!c venkatram and pleim (more adaptated to particles but numerically unstable)
    1531        IF(idrydep.EQ.2)THEN
     1531       IF(idrydep==2)THEN
    15321532        rexp=exp(-(ra+rb)*setvel(nb))
    15331533        vdout(nb)=setvel(nb)/(1.-rexp)
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/finemission.F

    r4593 r5082  
    6565
    6666      DO i=1,klon
    67          IF (iregion_ind(i).GT.0) THEN
     67         IF (iregion_ind(i)>0) THEN
    6868       IF(id_fine>0)    source_tr(i,id_fine)=source_tr(i,id_fine)+
    6969     .                (scale_param_ff(iregion_ind(i))*lmt_bcff(i)+     !g/m2/s
     
    8181     .                     *1.e4*1.e3
    8282         ENDIF
    83          IF (iregion_bb(i).GT.0) THEN
     83         IF (iregion_bb(i)>0) THEN
    8484       IF(id_fine>0)    source_tr(i,id_fine)=source_tr(i,id_fine)+
    8585     .                (scale_param_bb(iregion_bb(i))*lmt_bcbb_l(i)+   !g/m2/s
     
    132132          zzdz=zalt(i,kmaxbc+1)-zalt(i,kminbc)
    133133c
    134          IF (iregion_bb(i) .GT.0) THEN
     134         IF (iregion_bb(i) >0) THEN
    135135        IF(id_fine>0)   tr_seri(i,k,id_fine)=tr_seri(i,k,id_fine)+
    136136     .              (scale_param_bb(iregion_bb(i))*lmt_bcbb_h(i)+
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/inscav_spl.F

    r4593 r5082  
    5858c
    5959cnhl      IF (it.EQ.2.OR.it.EQ.3) THEN !--aerosol  ! AS IT WAS FIRST
    60       IF (it.EQ.2.OR.it.EQ.3.OR.it.EQ.4) THEN !--aerosol
     60      IF (it==2.OR.it==3.OR.it==4) THEN !--aerosol
    6161        frac=frac_aer
    6262      ELSE                                                !--gas
     
    6464      ENDIF
    6565c
    66       IF (it.EQ.1) THEN
     66      IF (it==1) THEN
    6767      DO k=1, klev
    6868      DO i=1, klon
     
    7575      ENDDO
    7676      ENDDO
    77       ELSEIF (it.EQ.2) THEN
     77      ELSEIF (it==2) THEN
    7878      DO k=1, klev
    7979      DO i=1, klon
     
    8181      ENDDO
    8282      ENDDO
    83       ELSEIF (it.EQ.3) THEN
     83      ELSEIF (it==3) THEN
    8484      DO k=1, klev
    8585      DO i=1, klon
     
    8787      ENDDO
    8888      ENDDO
    89       ELSEIF (it.EQ.4) THEN
     89      ELSEIF (it==4) THEN
    9090      DO k=1, klev
    9191      DO i=1, klon
     
    119119c--reevaporation
    120120        beta=flxr_aux(i,k)-flxr_aux(i,k+1)+flxs_aux(i,k)-flxs_aux(i,k+1)
    121         IF (beta.LT.0.) beta=beta/(flxr_aux(i,k+1)+flxs_aux(i,k+1))
    122         IF (flxr_aux(i,k)+flxs_aux(i,k).EQ.0) THEN  !--reevaporation totale
     121        IF (beta<0.) beta=beta/(flxr_aux(i,k+1)+flxs_aux(i,k+1))
     122        IF (flxr_aux(i,k)+flxs_aux(i,k)==0) THEN  !--reevaporation totale
    123123          beta=MIN(MAX(0.0,-beta),1.0)
    124124        ELSE                          !--reevaporation non totale pour aerosols
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/lsc_scav_orig.F90

    r2630 r5082  
    177177  ENDDO
    178178
    179     IF (it.gt.1) THEN                               !  aerosol   
     179    IF (it>1) THEN                               !  aerosol
    180180      frac_ev=frac_aer
    181181    ELSE                                                !  gas
     
    183183    ENDIF
    184184
    185     IF(it.gt.1) then  ! aerosol
     185    IF(it>1) then  ! aerosol
    186186     DO k=1, klev
    187187      DO i=1, klon
     
    203203!  incloud scavenging
    204204!   if(inscav_fisrt) then
    205    if (iflag_lscav .eq. 4) then
     205   if (iflag_lscav == 4) then
    206206      beta=beta_fisrt(i,k)*rneb(i,k)
    207207   else
     
    219219
    220220!  below-cloud impaction
    221     IF(it.eq.1) then
     221    IF(it==1) then
    222222      d_tr_bcscav(i,k,it)=0.
    223223    ELSE
     
    236236      deltaP(i,k)=max(deltaP(i,k),0.)
    237237
    238       if(flxr(i,k+1)+flxs(i,k+1).gt.1.e-16) then
     238      if(flxr(i,k+1)+flxs(i,k+1)>1.e-16) then
    239239       beta_ev(i,k)=deltaP(i,k)/(flxr(i,k+1)+flxs(i,k+1))
    240240      else
     
    246246!jyg
    247247     
    248       if(abs(1-(1-frac_ev)*beta_ev(i,k)).gt.1.e-16) then
     248      if(abs(1-(1-frac_ev)*beta_ev(i,k))>1.e-16) then
    249249! remove tracers from precipitation owing to release by evaporation in his_dh
    250250!      dxev=frac_ev*beta_ev(i,k)*his_dh(i) *pdtime/(zrho(i,k)*zdz(i,k)) &
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/lsc_scav_spl.F90

    r3786 r5082  
    188188
    189189!JE<<
    190     IF (it.eq.id_prec) THEN                               !  gas
     190    IF (it==id_prec) THEN                               !  gas
    191191      frac_ev=frac_gas
    192192    ELSE                                   !aerosol
     
    194194    ENDIF
    195195
    196     IF (it.eq.id_prec) THEN                               !  gas
     196    IF (it==id_prec) THEN                               !  gas
    197197     DO k=1, klev
    198198      DO i=1, klon
     
    214214!  incloud scavenging
    215215!   if(inscav_fisrt) then
    216    if (iflag_lscav .eq. 4) then
     216   if (iflag_lscav == 4) then
    217217      beta=beta_fisrt(i,k)*rneb(i,k)
    218218   else
     
    230230
    231231!  below-cloud impaction
    232     IF(it.eq.id_prec) then
     232    IF(it==id_prec) then
    233233      d_tr_bcscav(i,k,it)=0.
    234234    ELSE
     
    247247      deltaP(i,k)=max(deltaP(i,k),0.)
    248248
    249       if(flxr(i,k+1)+flxs(i,k+1).gt.1.e-16) then
     249      if(flxr(i,k+1)+flxs(i,k+1)>1.e-16) then
    250250       beta_ev(i,k)=deltaP(i,k)/(flxr(i,k+1)+flxs(i,k+1))
    251251      else
     
    257257!jyg
    258258     
    259       if(abs(1-(1-frac_ev)*beta_ev(i,k)).gt.1.e-16) then
     259      if(abs(1-(1-frac_ev)*beta_ev(i,k))>1.e-16) then
    260260! remove tracers from precipitation owing to release by evaporation in his_dh
    261261!      dxev=frac_ev*beta_ev(i,k)*his_dh(i) *pdtime/(zrho(i,k)*zdz(i,k)) &
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/minmaxqfi2.F

    r4593 r5082  
    2525      zqmax=zq(ijmax,lmax)
    2626 
    27       if(zqmin.lt.qmin.or.zqmax.gt.qmax)
     27      if(zqmin<qmin.or.zqmax>qmax)
    2828     s     write(*,9999) comment,
    2929     s     ijmin,lmin,zqmin,ijmax,lmax,zqmax
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/minmaxsource.F

    r4593 r5082  
    2626      zqmax=zq(ijmax,lmax)
    2727
    28       if(zqmin.lt.qmin.or.zqmax.gt.qmax)
     28      if(zqmin<qmin.or.zqmax>qmax)
    2929     s     write(*,9999) comment,
    3030     s     ijmin,lmin,zqmin,ijmax,lmax,zqmax
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/neutral.F

    r4593 r5082  
    4444        do i=1,klon
    4545
    46         if (u10_mps(i) .lt. 0.) u10_mps(i) = 0.0
     46        if (u10_mps(i) < 0.) u10_mps(i) = 0.0
    4747       
    48         if  (obklen_m(i) .lt. 0.) then
     48        if  (obklen_m(i) < 0.) then
    4949                phi = (1. - 160./obklen_m(i))**(-0.25)
    5050                phi_inv = 1./phi
     
    5656                f3 = atan(dum1)
    5757                psi = 2.*log(f1) + log(f2) - 2.*f3 + pi/2.   
    58         else if (obklen_m(i) .gt. 0.) then
     58        else if (obklen_m(i) > 0.) then
    5959                psi = -50. / obklen_m(i)
    6060        end if
     
    6262        u10n_mps(i) = u10_mps(i) + (ustar_mps(i) * psi /von_karman )
    6363c u10n set to 0. if -1 < obklen < 20
    64         if ((obklen_m(i).gt.-1.).and.(obklen_m(i).lt.20.)) then
     64        if ((obklen_m(i)>-1.).and.(obklen_m(i)<20.)) then
    6565            u10n_mps(i) = 0.
    6666        endif
    67         if (u10n_mps(i) .lt. 0.) u10n_mps(i) = 0.0
     67        if (u10n_mps(i) < 0.) u10n_mps(i) = 0.0
    6868
    6969        enddo
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/nightingale.F

    r4593 r5082  
    5959c equal to value at 30 deg C.
    6060
    61       IF (ftsol(i,is_oce) .LE. 303.15) THEN
     61      IF (ftsol(i,is_oce) <= 303.15) THEN
    6262         t1 = ftsol(i,is_oce)
    6363      ELSE
     
    7777     .        * lmt_dmsconc(i)/1.0e12 * schmidt_corr * RNAVO
    7878c
    79       IF (lmt_dmsconc(i).LE.1.e-20) lmt_dms(i)=0.0
     79      IF (lmt_dmsconc(i)<=1.e-20) lmt_dms(i)=0.0
    8080c
    8181      ENDDO
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/phys_output_write_spl_mod.F90

    r5075 r5082  
    680680       CALL histwrite_phy(o_tauy, zx_tmp_fi2d)
    681681
    682        IF (landice_opt .GE. 1 ) THEN
     682       IF (landice_opt >= 1 ) THEN
    683683          CALL histwrite_phy(o_snowsrf, snow_o)
    684684          CALL histwrite_phy(o_qsnow, qsnow)
     
    769769       CALL histwrite_phy(o_uq, uq)
    770770       CALL histwrite_phy(o_vq, vq)
    771        IF (iflag_con.GE.3) THEN ! sb
     771       IF (iflag_con>=3) THEN ! sb
    772772          CALL histwrite_phy(o_cape, cape)
    773773          CALL histwrite_phy(o_pbase, ema_pcb)
     
    865865          DO k=1, nlevSTD
    866866             bb2=clevSTD(k)
    867              IF (bb2.EQ."850".OR.bb2.EQ."700".OR. &
    868                 bb2.EQ."500".OR.bb2.EQ."200".OR. &
    869                 bb2.EQ."100".OR. &
    870                 bb2.EQ."50".OR.bb2.EQ."10") THEN
     867             IF (bb2=="850".OR.bb2=="700".OR. &
     868                bb2=="500".OR.bb2=="200".OR. &
     869                bb2=="100".OR. &
     870                bb2=="50".OR.bb2=="10") THEN
    871871                ll=ll+1
    872872                CALL histwrite_phy(o_uSTDlevs(ll),ulevSTD(:,k))
     
    882882       IF (vars_defined) THEN
    883883          DO i=1, klon
    884              IF (pctsrf(i,is_oce).GT.epsfra.OR. &
    885                   pctsrf(i,is_sic).GT.epsfra) THEN
     884             IF (pctsrf(i,is_oce)>epsfra.OR. &
     885                  pctsrf(i,is_sic)>epsfra) THEN
    886886                zx_tmp_fi2d(i) = (ftsol(i, is_oce) * pctsrf(i,is_oce)+ &
    887887                     ftsol(i, is_sic) * pctsrf(i,is_sic))/ &
     
    895895
    896896       ! Couplage convection-couche limite
    897        IF (iflag_con.GE.3) THEN
     897       IF (iflag_con>=3) THEN
    898898          IF (iflag_coupl>=1) THEN
    899899             CALL histwrite_phy(o_ale_bl, ale_bl)
     
    902902       ENDIF !(iflag_con.GE.3)
    903903       ! Wakes
    904        IF (iflag_con.EQ.3) THEN
     904       IF (iflag_con==3) THEN
    905905          IF (iflag_wake>=1) THEN
    906906             CALL histwrite_phy(o_ale_wk, ale_wake)
     
    924924          CALL histwrite_phy(o_fqd, fqd)
    925925       ENDIF !(iflag_con.EQ.3)
    926        IF (iflag_con.EQ.3.OR.iflag_con.EQ.30) THEN
     926       IF (iflag_con==3.OR.iflag_con==30) THEN
    927927          ! sortie RomP convection descente insaturee iflag_con=30
    928928          ! etendue a iflag_con=3 (jyg)
     
    953953          CALL histwrite_phy(o_slab_qflux, slab_wfbils)
    954954          !CALL histwrite_phy(o_slab_bils, slab_bils)
    955           IF (nslay.EQ.1) THEN
     955          IF (nslay==1) THEN
    956956              zx_tmp_fi2d(:)=tslab(:,1)
    957957              CALL histwrite_phy(o_tslab, zx_tmp_fi2d)
     
    10131013!--OLIVIER
    10141014!This is warranted by treating INCA aerosols as offline aerosols
    1015        IF (flag_aerosol.GT.0) THEN
     1015       IF (flag_aerosol>0) THEN
    10161016          CALL histwrite_phy(o_od550aer, od550aer)
    10171017          CALL histwrite_phy(o_od865aer, od865aer)
     
    10371037          !--STRAT AER
    10381038       ENDIF
    1039        IF (flag_aerosol.GT.0.OR.flag_aerosol_strat>=1) THEN
     1039       IF (flag_aerosol>0.OR.flag_aerosol_strat>=1) THEN
    10401040!          DO naero = 1, naero_spc
    10411041!--correction mini bug OB
     
    10831083          CALL histwrite_phy(o_solswai, solswai_aero)
    10841084       ENDIF
    1085        IF (flag_aerosol.GT.0.AND.ok_cdnc) THEN
     1085       IF (flag_aerosol>0.AND.ok_cdnc) THEN
    10861086          CALL histwrite_phy(o_scdnc, scdnc)
    10871087          CALL histwrite_phy(o_cldncl, cldncl)
     
    12151215       ENDIF
    12161216       CALL histwrite_phy(o_dtcon, zx_tmp_fi3d)
    1217        IF (iflag_thermals.eq.0)THEN
     1217       IF (iflag_thermals==0)THEN
    12181218          IF (vars_defined) THEN
    12191219             zx_tmp_fi3d(1:klon,1:klev)=d_t_con(1:klon,1:klev)/pdtphys + &
     
    12211221          ENDIF
    12221222          CALL histwrite_phy(o_tntc, zx_tmp_fi3d)
    1223        ELSEIF (iflag_thermals.ge.1.and.iflag_wake.EQ.1)THEN
     1223       ELSEIF (iflag_thermals>=1.and.iflag_wake==1)THEN
    12241224          IF (vars_defined) THEN
    12251225             zx_tmp_fi3d(1:klon,1:klev)=d_t_con(1:klon,1:klev)/pdtphys + &
     
    12361236       CALL histwrite_phy(o_dqcon, zx_tmp_fi3d)
    12371237
    1238        IF (iflag_thermals.EQ.0) THEN
     1238       IF (iflag_thermals==0) THEN
    12391239          IF (vars_defined) zx_tmp_fi3d(1:klon,1:klev)=d_q_con(1:klon,1:klev)/pdtphys
    12401240          CALL histwrite_phy(o_tnhusc, zx_tmp_fi3d)
    1241        ELSEIF (iflag_thermals.GE.1.AND.iflag_wake.EQ.1) THEN
     1241       ELSEIF (iflag_thermals>=1.AND.iflag_wake==1) THEN
    12421242          IF (vars_defined) THEN
    12431243             zx_tmp_fi3d(1:klon,1:klev)=d_q_con(1:klon,1:klev)/pdtphys + &
     
    14491449       CALL histwrite_phy(o_ref_liq, ref_liq)
    14501450       CALL histwrite_phy(o_ref_ice, ref_ice)
    1451        IF (RCO2_per.NE.RCO2_act.OR.RCH4_per.NE.RCH4_act.OR. &
    1452             RN2O_per.NE.RN2O_act.OR.RCFC11_per.NE.RCFC11_act.OR. &
    1453             RCFC12_per.NE.RCFC12_act) THEN
     1451       IF (RCO2_per/=RCO2_act.OR.RCH4_per/=RCH4_act.OR. &
     1452            RN2O_per/=RN2O_act.OR.RCFC11_per/=RCFC11_act.OR. &
     1453            RCFC12_per/=RCFC12_act) THEN
    14541454          IF (vars_defined) zx_tmp_fi2d(1 : klon) = swupp ( 1 : klon, klevp1 )
    14551455          CALL histwrite_phy(o_rsut4co2, zx_tmp_fi2d)
     
    15751575             DO k=1, nlevSTD
    15761576                DO i=1, klon
    1577                    IF (O3STD(i,k).NE.missing_val) THEN
     1577                   IF (O3STD(i,k)/=missing_val) THEN
    15781578                      zx_tmp_fi3d_STD(i,k) = O3STD(i,k) * 1.e+9
    15791579                   ELSE
     
    15881588                DO k=1, nlevSTD
    15891589                   DO i=1, klon
    1590                       IF (O3daySTD(i,k).NE.missing_val) THEN
     1590                      IF (O3daySTD(i,k)/=missing_val) THEN
    15911591                         zx_tmp_fi3d_STD(i,k) = O3daySTD(i,k) * 1.e+9
    15921592                      ELSE
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/phytracr_spl_mod.F90

    r5075 r5082  
    9494  LOGICAL , parameter :: edgar = .true.
    9595  INTEGER , parameter :: flag_dms=4
    96   INTEGER*4  nbjour
     96  INTEGER(kind=4)  nbjour
    9797
    9898      !
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/precuremission.F

    r4593 r5082  
    105105
    106106      DO i=1, klon
    107          IF (iregion_ind(i).GT.0) THEN
     107         IF (iregion_ind(i)>0) THEN
    108108       IF(id_prec>0) source_tr(i,id_prec)=source_tr(i,id_prec)
    109109     .             + fracso2emis
     
    137137     .               *1.e4/RNAVO*masse_ammsulfate*1.e3    ! mgS/m2/s
    138138         ENDIF
    139          IF (iregion_bb(i).GT.0) THEN
     139         IF (iregion_bb(i)>0) THEN
    140140      IF(id_prec>0) source_tr(i,id_prec)=
    141141     .                  source_tr(i,id_prec) + fracso2emis
     
    213213      DO i = 1, klon
    214214        zaltmid(i,k)=zalt(i,k)+zdz(i,k)/2.
    215         IF (zalt(i,k+1).LT.lmt_altvolc_cont(i)) kkk_cont(i)=k+1
    216         IF (zalt(i,k+1).LT.lmt_altvolc_expl(i)) kkk_expl(i)=k+1
     215        IF (zalt(i,k+1)<lmt_altvolc_cont(i)) kkk_cont(i)=k+1
     216        IF (zalt(i,k+1)<lmt_altvolc_expl(i)) kkk_expl(i)=k+1
    217217      ENDDO
    218218      ENDDO
     
    234234      DO i = 1, klon
    235235c
    236          IF (iregion_bb(i).GT.0) THEN
     236         IF (iregion_bb(i)>0) THEN
    237237      IF(id_prec>0)   tr_seri(i,k,id_prec)=
    238238     .              tr_seri(i,k,id_prec) + fracso2emis
     
    245245     .              *masse_ammsulfate/RNAVO/zdz(i,k)/100.*pdtphys   !g/cm3
    246246         ENDIF
    247          IF (iregion_ind(i).GT.0) THEN
     247         IF (iregion_ind(i)>0) THEN
    248248       IF(id_prec>0)  tr_seri(i,k,id_prec)=
    249249     .              tr_seri(i,k,id_prec) + (fracso2emis
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/read_newemissions.F

    r4593 r5082  
    204204      print *,'READ_EMISSION: test_vent & test_day = ',test_vent,
    205205     +                                                 test_day
    206       IF (test_vent.EQ.0) THEN    !--on lit toutes les 6 h                                                                     
     206      IF (test_vent==0) THEN    !--on lit toutes les 6 h
    207207        CALL SCOPY(klon, u10m_ec2, 1, u10m_ec1, 1)
    208208        CALL SCOPY(klon, v10m_ec2, 1, v10m_ec1, 1)
     
    246246      jH_vent=jH_vent+pdtphys/(24.*3600.)
    247247      test_vent=test_vent+1
    248       IF (jH_vent.GT.(vent_resol)/24.) THEN
     248      IF (jH_vent>(vent_resol)/24.) THEN
    249249          test_vent=0
    250250          jH_vent=jH_init
     
    258258      DO i=1, klon
    259259c
    260         IF (cly(i).LT.9990..AND.wth(i).LT.9990.) THEN
     260        IF (cly(i)<9990..AND.wth(i)<9990.) THEN
    261261          zprecipinsoil(i)=zprecipinsoil(i) +
    262262     .           (pmflxr(i,1)+pmflxs(i,1)+prfl(i,1)+psfl(i,1))*pdtphys
     
    277277      icount=0
    278278      DO i=1, klon
    279         IF (cly(i).GE.9990..OR.wth(i).GE.9990..OR.
    280      .     t_seri(i,1).LE.273.15.OR.zprecipinsoil(i).GT.1.e-8) THEN
     279        IF (cly(i)>=9990..OR.wth(i)>=9990..OR.
     280     .     t_seri(i,1)<=273.15.OR.zprecipinsoil(i)>1.e-8) THEN
    281281             dust_ec(i)=0.0 ! commented out for test dustemtest
    282282!             print *,'Dust emissions surpressed at grid = ',i
     
    330330c
    331331     
    332       IF (test_day.EQ.0) THEN
     332      IF (test_day==0) THEN
    333333        print *,'Computing SULFATE emissions for day : ',iday,julien,
    334334     .                                                   step_vent
     
    362362      jH_day=jH_day+pdtphys/(24.*3600.)
    363363      test_day=test_day+1
    364       IF (jH_day.GT.(day_resol)/24.) THEN
     364      IF (jH_day>(day_resol)/24.) THEN
    365365          print *,'LAST TIME STEP OF DAY ',julien
    366366          test_day=0
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/satellite_out_spla.F90

    r2630 r5082  
    170170     lon_cen=(ATAN(TAN(tempo)*COS(incli))-duree_orb*tempo)*RADEG
    171171     demi_larg=demi_larg_eq/COS(rlat(i)*DTOR)
    172      IF (ABS(SIN(rlat(i)*DTOR)/SIN(incli)).GE.1.0) demi_larg=200.0
    173      IF (rlat(i).GE.lat_fin.AND.rlat(i).LE.lat_debut) THEN
    174         IF (demi_larg.GE. 180.) THEN
     172     IF (ABS(SIN(rlat(i)*DTOR)/SIN(incli))>=1.0) demi_larg=200.0
     173     IF (rlat(i)>=lat_fin.AND.rlat(i)<=lat_debut) THEN
     174        IF (demi_larg>= 180.) THEN
    175175           masque(i)=1
    176176        ELSE 
     
    178178           lon_east = MOD(lon0+lon_cen+demi_larg,      360.)
    179179           zlon     = MOD(rlon(i)+360.,                360.)
    180            IF (lon_west.LE.lon_east) THEN
    181               IF (zlon.GE.lon_west.AND.zlon.LE.lon_east) masque(i)=1
     180           IF (lon_west<=lon_east) THEN
     181              IF (zlon>=lon_west.AND.zlon<=lon_east) masque(i)=1
    182182           ELSE               
    183               IF (zlon.GE.lon_west.OR.zlon.LE.lon_east) masque(i)=1
     183              IF (zlon>=lon_west.OR.zlon<=lon_east) masque(i)=1
    184184           ENDIF
    185185        ENDIF
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/sediment_mod.F

    r4593 r5082  
    106106       temp=t_seri(i,k)-RTT
    107107c
    108        IF (temp.LT.0.) THEN
     108       IF (temp<0.) THEN
    109109         air_visco(i,k)=(1.718+0.0049*temp-1.2e-5*temp*temp)*1.e-4
    110110       ELSE
     
    127127        rh=MIN(RHcl(i,k)*100.,RH_MAX)
    128128        RH_num = INT( rh/10. + 1.)
    129         IF (rh.gt.85.) RH_num=10
    130         IF (rh.gt.90.) RH_num=11
     129        IF (rh>85.) RH_num=10
     130        IF (rh>90.) RH_num=11
    131131        DELTA=(rh-RH_tab(RH_num))/(RH_tab(RH_num+1)-RH_tab(RH_num))
    132132c
     
    149149c---------check for v_sed*dt<zdz
    150150c
    151        IF (v_sed*time_step.GT.zdz(i,k)) THEN
     151       IF (v_sed*time_step>zdz(i,k)) THEN
    152152         v_sed=zdz(i,k)/time_step     
    153153       ENDIF
     
    216216c---------check for v_sed*dt<zdz
    217217c
    218        IF (v_sed*time_step.GT.zdz(i,k)) THEN
     218       IF (v_sed*time_step>zdz(i,k)) THEN
    219219         v_sed=zdz(i,k)/time_step     
    220220       ENDIF
     
    285285
    286286
    287        IF (v_sed*time_step.GT.zdz(i,k)) THEN
     287       IF (v_sed*time_step>zdz(i,k)) THEN
    288288         v_sed=zdz(i,k)/time_step
    289289       ENDIF
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/splaeropt_5wv_rrtm.F90

    r4163 r5082  
    9494  modname='splaeropt_5wv_rrtm'
    9595
    96   IF (naero.GT.naero_tot) THEN
     96  IF (naero>naero_tot) THEN
    9797    CALL abort_physic(modname,'Too many aerosol types',1)
    9898  ENDIF
     
    106106      rh(i,k)=MIN(RHcl(i,k)*100.,RH_MAX)
    107107      RH_num(i,k) = INT( rh(i,k)/10. + 1.)
    108       IF (rh(i,k).GT.85.) RH_num(i,k)=10
    109       IF (rh(i,k).GT.90.) RH_num(i,k)=11
     108      IF (rh(i,k)>85.) RH_num(i,k)=10
     109      IF (rh(i,k)>90.) RH_num(i,k)=11
    110110      delta(i,k)=(rh(i,k)-RH_tab(RH_num(i,k)))*fact_RH(RH_num(i,k))
    111111    ENDDO
     
    128128
    129129      !--only 550 and 865 nm are used
    130       IF (la.NE.la550.AND.la.NE.la865) CYCLE
     130      IF (la/=la550.AND.la/=la865) CYCLE
    131131
    132132      IF (soluble) THEN  !--soluble aerosol with RH dependence
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/splaeropt_6bands_rrtm.F90

    r4163 r5082  
    143143  modname='splaeropt_6bands_rrt'
    144144
    145   IF (NSW.NE.nbands_sw_rrtm) THEN
     145  IF (NSW/=nbands_sw_rrtm) THEN
    146146     CALL abort_physic(modname,'Erreur NSW doit etre egal a 6 pour cette routine',1)
    147147  ENDIF
     
    155155      rh(i,k)=MIN(RHcl(i,k)*100.,RH_MAX)
    156156      RH_num(i,k) = INT(rh(i,k)/10. + 1.)
    157       IF (rh(i,k).GT.85.) RH_num(i,k)=10
    158       IF (rh(i,k).GT.90.) RH_num(i,k)=11
     157      IF (rh(i,k)>85.) RH_num(i,k)=10
     158      IF (rh(i,k)>90.) RH_num(i,k)=11
    159159      delta(i,k)=(rh(i,k)-RH_tab(RH_num(i,k)))*fact_RH(RH_num(i,k))
    160160    ENDDO
     
    236236  piz_allaer(:,:,2,:)=SUM(tau_ae(:,:,1:naero,:)*piz_ae(:,:,1:naero,:),dim=3)/tau_allaer(:,:,2,:)
    237237  piz_allaer(:,:,2,:)=MIN(MAX(piz_allaer(:,:,2,:),0.01),1.0)
    238   WHERE (tau_allaer(:,:,2,:).LE.tau_min) piz_allaer(:,:,2,:)=1.0
     238  WHERE (tau_allaer(:,:,2,:)<=tau_min) piz_allaer(:,:,2,:)=1.0
    239239
    240240  cg_allaer(:,:,2,:)=SUM(tau_ae(:,:,1:naero,:)*piz_ae(:,:,1:naero,:)*cg_ae(:,:,1:naero,:),dim=3)/  &
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/splaeropt_lw_rrtm.F90

    r4071 r5082  
    4545  modname='splaeropt_lw_rrtm'
    4646  !
    47   IF (NLW.NE.nbands_lw_rrtm) THEN
     47  IF (NLW/=nbands_lw_rrtm) THEN
    4848    CALL abort_physic(modname,'Erreur NLW doit etre egal a 16 pour cette routine',1)
    4949  ENDIF
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/tiedqneg.F

    r4593 r5082  
    2929        nb_neg = 0
    3030        DO i = 1,klon
    31           IF (q(i,l)+d_q(i,l).LT.qmin) THEN
     31          IF (q(i,l)+d_q(i,l)<qmin) THEN
    3232          nb_neg = nb_neg + 1
    3333          d_q(i,l-1) = d_q(i,l-1) + (q(i,l)+d_q(i,l)-qmin)
     
    4444        nb_neg = 0
    4545        DO i = 1,klon
    46           IF (q(i,l)+d_q(i,l).LT.qmin) THEN
     46          IF (q(i,l)+d_q(i,l)<qmin) THEN
    4747          nb_neg = nb_neg + 1
    4848          d_q(i,l+1) = d_q(i,l+1) + (q(i,l)+d_q(i,l)-qmin)
     
    5858      l = klev
    5959      DO i = 1,klon
    60         IF (q(i,l)+d_q(i,l).LT.qmin) THEN
     60        IF (q(i,l)+d_q(i,l)<qmin) THEN
    6161          d_q(i,l) = qmin - q(i,l)
    6262        ENDIF
  • LMDZ6/branches/Amaury_dev/libf/phylmd/Dust/trconvect.F

    r4593 r5082  
    7070      DO k = 1, klev
    7171      DO i = 1, klon
    72         IF (d_tr(i,k,it).LT.0.) THEN
     72        IF (d_tr(i,k,it)<0.) THEN
    7373          tr_seri(i,k,it)=tr_seri(i,k,it)+d_tr(i,k,it)
    7474        ELSE
     
    8888      DO k = 1, klev
    8989      DO i = 1, klon
    90         IF (d_tr(i,k,it).GE.0.) THEN
     90        IF (d_tr(i,k,it)>=0.) THEN
    9191        dtrconv(i,it)=dtrconv(i,it)+(1.-xconv(it))*d_tr(i,k,it)
    9292     .                /RNAVO*masse(it)*1.e3*1.e6*zdz(i,k)/pdtphys
Note: See TracChangeset for help on using the changeset viewer.