Ignore:
Timestamp:
Sep 11, 2024, 4:27:07 PM (2 months ago)
Author:
abarral
Message:

Replace REPROBUS CPP KEY by logical using handmade wonky wrapper

Location:
LMDZ6/branches/Amaury_dev/libf/phylmd/cosp
Files:
21 edited

Legend:

Unmodified
Added
Removed
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/MISR_simulator.F

    r5099 r5185  
    181181        ! NOW for MISR ..
    182182        ! if there a cloud ... start the counter ... store this height
    183         if(thres_crossed_MISR .eq. 0 .and. dtau .gt. 0.) then
     183        if(thres_crossed_MISR .eq. 0 .AND. dtau .gt. 0.) then
    184184       
    185185            ! first encountered a "cloud"
     
    188188        endif   
    189189               
    190         if( thres_crossed_MISR .lt. 99 .and.
     190        if( thres_crossed_MISR .lt. 99 .AND.
    191191     &              thres_crossed_MISR .gt. 0 ) then
    192192     
     
    207207            ! then MISR will like see a top below the top of the current
    208208            ! layer
    209             if( dtau.gt.0 .and. (cloud_dtau-dtau) .lt. 1) then
     209            if( dtau.gt.0 .AND. (cloud_dtau-dtau) .lt. 1) then
    210210           
    211211                if(dtau .lt. 1 .or. ilev.eq.1 .or. ilev.eq.nlev) then
     
    228228       
    229229            ! check for a distinctive water layer
    230             if(dtau .gt. 1 .and. at(j,ilev).gt.273 ) then
     230            if(dtau .gt. 1 .AND. at(j,ilev).gt.273 ) then
    231231     
    232232                    ! must be a water cloud ...
     
    292292           do j=2,npoints-1
    293293           
    294             if(box_MISR_ztop(j-1,1).gt.0 .and.
     294            if(box_MISR_ztop(j-1,1).gt.0 .AND.
    295295     &             box_MISR_ztop(j+1,1).gt.0       ) then
    296296
    297297                if( abs( box_MISR_ztop(j-1,1) - 
    298298     &                   box_MISR_ztop(j+1,1) ) .lt. 500
    299      &              .and.
     299     &              .AND.
    300300     &                   box_MISR_ztop(j,1) .lt.
    301301     &                   box_MISR_ztop(j+1,1)     ) then
     
    312312         do ibox=2,ncol-1
    313313           
    314             if(box_MISR_ztop(1,ibox-1).gt.0 .and.
     314            if(box_MISR_ztop(1,ibox-1).gt.0 .AND.
    315315     &             box_MISR_ztop(1,ibox+1).gt.0        ) then
    316316
    317317                if( abs( box_MISR_ztop(1,ibox-1) - 
    318318     &                   box_MISR_ztop(1,ibox+1) ) .lt. 500
    319      &              .and.
     319     &              .AND.
    320320     &                   box_MISR_ztop(1,ibox) .lt.
    321321     &                   box_MISR_ztop(1,ibox+1)     ) then
     
    361361                  itau=1
    362362              else if (tau(j,ibox) .ge. isccp_taumin                                   
    363      &          .and. tau(j,ibox) .lt. 1.3) then
     363     &          .AND. tau(j,ibox) .lt. 1.3) then
    364364                  itau=2
    365365              else if (tau(j,ibox) .ge. 1.3
    366      &          .and. tau(j,ibox) .lt. 3.6) then
     366     &          .AND. tau(j,ibox) .lt. 3.6) then
    367367                  itau=3
    368368              else if (tau(j,ibox) .ge. 3.6
    369      &          .and. tau(j,ibox) .lt. 9.4) then
     369     &          .AND. tau(j,ibox) .lt. 9.4) then
    370370                  itau=4
    371371              else if (tau(j,ibox) .ge. 9.4
    372      &          .and. tau(j,ibox) .lt. 23.) then
     372     &          .AND. tau(j,ibox) .lt. 23.) then
    373373                  itau=5
    374374              else if (tau(j,ibox) .ge. 23.
    375      &          .and. tau(j,ibox) .lt. 60.) then
     375     &          .AND. tau(j,ibox) .lt. 60.) then
    376376                  itau=6
    377377              else if (tau(j,ibox) .ge. 60.) then
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/calc_Re.F90

    r5160 r5185  
    6363
    6464  ! // if density is constant, set equivalent values for apm and bpm
    65   if ((rho_c > 0) .and. (apm < 0)) then
     65  if ((rho_c > 0) .AND. (apm < 0)) then
    6666    apm = (pi/6)*rho_c
    6767    bpm = 3.
     
    7070  ! Exponential is same as modified gamma with vu =1
    7171  ! if Np is specified then we will just treat as modified gamma
    72   if(dtype.eq.2 .and. Np>0) then
     72  if(dtype.eq.2 .AND. Np>0) then
    7373    local_dtype=1;
    7474    local_p3=1;
     
    117117   
    118118
    119     if( Np.eq.0 .and. p2+1 > 1E-8) then     ! use default value for MEAN diameter as first default
     119    if( Np.eq.0 .AND. p2+1 > 1E-8) then     ! use default value for MEAN diameter as first default
    120120     
    121121        dm = p2             ! by definition, should have units of microns
     
    231231     
    232232    ! get rg ...
    233     if( Np.eq.0 .and. (abs(p2+1) > 1E-8) ) then ! use default value of rg
     233    if( Np.eq.0 .AND. (abs(p2+1) > 1E-8) ) then ! use default value of rg
    234234   
    235235            rg = p2
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/cosp_output_write_mod.F90

    r5158 r5185  
    185185    DO k=1,PARASOL_NREFL
    186186     DO ip=1, Npoints
    187       if (stlidar%cldlayer(ip,4).gt.0.01.and.stlidar%parasolrefl(ip,k).ne.missing_val) then
     187      if (stlidar%cldlayer(ip,4).gt.0.01.AND.stlidar%parasolrefl(ip,k).ne.missing_val) then
    188188        parasolcrefl(ip,k)=(stlidar%parasolrefl(ip,k)-0.03*(1.-stlidar%cldlayer(ip,4)))/ &
    189189                             stlidar%cldlayer(ip,4)
     
    240240
    241241!!! Sorties combinees Cloudsat et Calipso
    242  if (cfg%Llidar_sim .and. cfg%Lradar_sim) then
     242 if (cfg%Llidar_sim .AND. cfg%Lradar_sim) then
    243243   where(stradar%lidar_only_freq_cloud == R_UNDEF) &
    244244                           stradar%lidar_only_freq_cloud = missing_val
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/cosp_read_otputkeys.F90

    r5160 r5185  
    439439    Ltbrttov = .false.
    440440  endif
    441   if ((.not.Lradar_sim).and.(.not.Llidar_sim).and. &
    442       (.not.Lisccp_sim).and.(.not.Lmisr_sim)) then
     441  if ((.not.Lradar_sim).AND.(.not.Llidar_sim).AND. &
     442      (.not.Lisccp_sim).AND.(.not.Lmisr_sim)) then
    443443    Lfracout = .false.
    444444    Lstats = .false.
     
    469469
    470470  ! Diagnostics that use Radar and Lidar
    471   if (((Lclcalipso2).or.(Lcltlidarradar)).and.((Lradar_sim).or.(Llidar_sim))) then
     471  if (((Lclcalipso2).or.(Lcltlidarradar)).AND.((Lradar_sim).or.(Llidar_sim))) then
    472472    Lclcalipso2    = .true.
    473473    Lcltlidarradar = .true.
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/dsd.F90

    r5160 r5185  
    9191 
    9292  ! // if density is constant, store equivalent values for apm and bpm
    93   if ((rho_c > 0) .and. (apm < 0)) then
     93  if ((rho_c > 0) .AND. (apm < 0)) then
    9494    apm = (pi/6)*rho_c
    9595    bpm = 3.
     
    9999  ! if only Np given then calculate Re
    100100  ! if neigher than use other defaults (p1,p2,p3) following quickbeam documentation
    101   if(Re==0 .and. Np>0) then
     101  if(Re==0 .AND. Np>0) then
    102102   
    103103        call calc_Re(Q,Np,rho_a, &
     
    270270      if (tc < -30) then
    271271        bhp = -1.75+0.09*((tc+273)-243.16)
    272       elseif ((tc >= -30) .and. (tc < -9)) then
     272      elseif ((tc >= -30) .AND. (tc < -9)) then
    273273        bhp = -3.25-0.06*((tc+273)-265.66)
    274274      else
     
    280280      if (tc < -35) then
    281281        bhp = -1.75+0.09*((tc+273)-243.16)
    282       elseif ((tc >= -35) .and. (tc < -17.5)) then
     282      elseif ((tc >= -35) .AND. (tc < -17.5)) then
    283283        bhp = -2.65+0.09*((tc+273)-255.66)
    284       elseif ((tc >= -17.5) .and. (tc < -9)) then
     284      elseif ((tc >= -17.5) .AND. (tc < -9)) then
    285285        bhp = -3.25-0.06*((tc+273)-265.66)
    286286      else
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/format_input.F90

    r5158 r5185  
    114114! :: space-based: heights must be descending
    115115  if ( &
    116      (sfc_radar == 1 .and. hgt_descending) .or.  &
    117      (sfc_radar == 0 .and. (.not. hgt_descending)) &
     116     (sfc_radar == 1 .AND. hgt_descending) .or.  &
     117     (sfc_radar == 0 .AND. (.not. hgt_descending)) &
    118118     ) &
    119119  then
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/icarus.F

    r5099 r5185  
    364364      do 12 ilev=1,nlev
    365365        do j=1,npoints
    366          if (pfull(j,ilev) .lt. 40000. .and.
    367      &          pfull(j,ilev) .gt.  5000. .and.
     366         if (pfull(j,ilev) .lt. 40000. .AND.
     367     &          pfull(j,ilev) .gt.  5000. .AND.
    368368     &          at(j,ilev) .lt. attropmin(j)) then
    369369                ptrop(j) = pfull(j,ilev)
     
    377377      do 13 ilev=1,nlev
    378378        do j=1,npoints
    379            if (at(j,ilev) .gt. atmax(j) .and.
     379           if (at(j,ilev) .gt. atmax(j) .AND.
    380380     &              ilev  .ge. itrop(j)) atmax(j)=at(j,ilev)
    381381        enddo
     
    811811          if (top_height .eq. 1) then
    812812            do j=1,npoints 
    813               if (transmax(j) .gt. 0.001 .and.
     813              if (transmax(j) .gt. 0.001 .AND.
    814814     &          transmax(j) .le. 0.9999999) then
    815815                fluxtopinit(j) = fluxtop(j,ibox)
     
    820820              do j=1,npoints 
    821821                if (tau(j,ibox) .gt. (tauchk            )) then
    822                 if (transmax(j) .gt. 0.001 .and.
     822                if (transmax(j) .gt. 0.001 .AND.
    823823     &            transmax(j) .le. 0.9999999) then
    824824                  emcld(j,ibox) = 1. - exp(-1. * tauir(j)  )
     
    845845                !at this point in the code
    846846                tb(j,ibox)= 1307.27/ (log(1. + (1./fluxtop(j,ibox))))
    847                 if (top_height.eq.1.and.tauir(j).lt.taumin(j)) then
     847                if (top_height.eq.1.AND.tauir(j).lt.taumin(j)) then
    848848                         tb(j,ibox) = attrop(j) - 5.
    849849                   tau(j,ibox) = 2.13*taumin(j)
     
    930930            do j=1,npoints
    931931             if (ilev .ge. itrop(j)) then
    932               if ((at(j,ilev)   .ge. tb(j,ibox) .and.
     932              if ((at(j,ilev)   .ge. tb(j,ibox) .AND.
    933933     &          at(j,ilev+1) .le. tb(j,ibox)) .or.
    934      &          (at(j,ilev) .le. tb(j,ibox) .and.
     934     &          (at(j,ilev) .le. tb(j,ibox) .AND.
    935935     &          at(j,ilev+1) .ge. tb(j,ibox))) then
    936936                nmatch(j)=nmatch(j)+1
     
    976976            do j=1,npoints     
    977977              if ((ptop(j,ibox) .eq. 0. )
    978      &           .and.(frac_out(j,ibox,ilev) .ne. 0)) then
     978     &           .AND.(frac_out(j,ibox,ilev) .ne. 0)) then
    979979                ptop(j,ibox)=phalf(j,ilev)
    980980              levmatch(j,ibox)=ilev
     
    10481048
    10491049          if (tau(j,ibox) .gt. (tauchk            )
    1050      &      .and. ptop(j,ibox) .gt. 0.) then
     1050     &      .AND. ptop(j,ibox) .gt. 0.) then
    10511051              box_cloudy(j,ibox)=.true.
    10521052          endif
     
    10981098              else if (tau(j,ibox) .ge. isccp_taumin
    10991099     &                                   
    1100      &          .and. tau(j,ibox) .lt. 1.3) then
     1100     &          .AND. tau(j,ibox) .lt. 1.3) then
    11011101                itau(j)=2
    11021102              else if (tau(j,ibox) .ge. 1.3
    1103      &          .and. tau(j,ibox) .lt. 3.6) then
     1103     &          .AND. tau(j,ibox) .lt. 3.6) then
    11041104                itau(j)=3
    11051105              else if (tau(j,ibox) .ge. 3.6
    1106      &          .and. tau(j,ibox) .lt. 9.4) then
     1106     &          .AND. tau(j,ibox) .lt. 9.4) then
    11071107                  itau(j)=4
    11081108              else if (tau(j,ibox) .ge. 9.4
    1109      &          .and. tau(j,ibox) .lt. 23.) then
     1109     &          .AND. tau(j,ibox) .lt. 23.) then
    11101110                  itau(j)=5
    11111111              else if (tau(j,ibox) .ge. 23.
    1112      &          .and. tau(j,ibox) .lt. 60.) then
     1112     &          .AND. tau(j,ibox) .lt. 60.) then
    11131113                  itau(j)=6
    11141114              else if (tau(j,ibox) .ge. 60.) then
     
    11181118              !determine cloud top pressure category
    11191119              if (    ptop(j,ibox) .gt. 0. 
    1120      &          .and.ptop(j,ibox) .lt. 180.) then
     1120     &          .AND.ptop(j,ibox) .lt. 180.) then
    11211121                  ipres(j)=1
    11221122              else if(ptop(j,ibox) .ge. 180.
    1123      &          .and.ptop(j,ibox) .lt. 310.) then
     1123     &          .AND.ptop(j,ibox) .lt. 310.) then
    11241124                  ipres(j)=2
    11251125              else if(ptop(j,ibox) .ge. 310.
    1126      &          .and.ptop(j,ibox) .lt. 440.) then
     1126     &          .AND.ptop(j,ibox) .lt. 440.) then
    11271127                  ipres(j)=3
    11281128              else if(ptop(j,ibox) .ge. 440.
    1129      &          .and.ptop(j,ibox) .lt. 560.) then
     1129     &          .AND.ptop(j,ibox) .lt. 560.) then
    11301130                  ipres(j)=4
    11311131              else if(ptop(j,ibox) .ge. 560.
    1132      &          .and.ptop(j,ibox) .lt. 680.) then
     1132     &          .AND.ptop(j,ibox) .lt. 680.) then
    11331133                  ipres(j)=5
    11341134              else if(ptop(j,ibox) .ge. 680.
    1135      &          .and.ptop(j,ibox) .lt. 800.) then
     1135     &          .AND.ptop(j,ibox) .lt. 800.) then
    11361136                  ipres(j)=6
    11371137              else if(ptop(j,ibox) .ge. 800.) then
     
    11401140
    11411141              !update frequencies
    1142               if(ipres(j) .gt. 0.and.itau(j) .gt. 0) then
     1142              if(ipres(j) .gt. 0.AND.itau(j) .gt. 0) then
    11431143              fq_isccp(j,itau(j),ipres(j))=
    11441144     &          fq_isccp(j,itau(j),ipres(j))+ boxarea
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/mod_cosp.F90

    r5160 r5185  
    139139      !     and reff_zero    == .false.  Reff use in lidar and set to 0 for radar
    140140  endif
    141   if ((.not. gbx%use_reff) .and. (reff_zero)) then ! No Reff in radar. Default in lidar
     141  if ((.not. gbx%use_reff) .AND. (reff_zero)) then ! No Reff in radar. Default in lidar
    142142        gbx%Reff = DEFAULT_LIDAR_REFF
    143143        PRINT *, '---------- COSP WARNING ------------'
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/mod_cosp_isccp_simulator.F90

    r5158 r5185  
    8888 
    8989  ! Check if there is any value slightly greater than 1
    90   where ((y%totalcldarea > 1.0-1.e-5) .and. (y%totalcldarea < 1.0+1.e-5))
     90  where ((y%totalcldarea > 1.0-1.e-5) .AND. (y%totalcldarea < 1.0+1.e-5))
    9191    y%totalcldarea = 1.0
    9292  endwhere
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/mod_cosp_radar.F90

    r5158 r5185  
    144144
    145145      if ( &
    146          (gbx%surface_radar == 1 .and. hgt_descending) .or.  &
    147          (gbx%surface_radar == 0 .and. (.not. hgt_descending)) &
     146         (gbx%surface_radar == 1 .AND. hgt_descending) .or.  &
     147         (gbx%surface_radar == 0 .AND. (.not. hgt_descending)) &
    148148         ) &
    149149      then
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/mod_cosp_simulator.F90

    r5160 r5185  
    8686!   do j=1,gbx%Nlevels
    8787!   do i=1,gbx%Npoints
    88 !     if ((gbx%mr_hydro(i,j,k)>0.0).and.(gbx%Reff(i,j,k)<=0.0)) inconsistent=.true.
     88!     if ((gbx%mr_hydro(i,j,k)>0.0).AND.(gbx%Reff(i,j,k)<=0.0)) inconsistent=.true.
    8989!   enddo
    9090!   enddo
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/mod_cosp_stats.F90

    r5158 r5185  
    140140
    141141        !++++++++++++ Lidar-only cloud amount and lidar&radar total cloud mount ++++++++++++++++
    142         if (cfg%Lradar_sim.and.cfg%Llidar_sim) call cosp_lidar_only_cloud(Npoints,Ncolumns,Nlr, &
     142        if (cfg%Lradar_sim.AND.cfg%Llidar_sim) call cosp_lidar_only_cloud(Npoints,Ncolumns,Nlr, &
    143143                                    temp_c,betatot_out,betaperptot_out,betamol_c,Ze_out, &
    144144                                    stradar%lidar_only_freq_cloud,stradar%radar_lidar_tcc)
     
    162162                        ,stlidar%parasolrefl,vgrid%z,stlidar%profSR)                    !OPAQ !TIBO
    163163        !++++++++++++ Lidar-only cloud amount and lidar&radar total cloud mount ++++++++++++++++
    164         if (cfg%Lradar_sim.and.cfg%Llidar_sim) call cosp_lidar_only_cloud(Npoints,Ncolumns,Nlr, &
     164        if (cfg%Lradar_sim.AND.cfg%Llidar_sim) call cosp_lidar_only_cloud(Npoints,Ncolumns,Nlr, &
    165165                                    sglidar%temp_tot,sglidar%beta_tot,sglidar%betaperp_tot,sglidar%beta_mol,sgradar%Ze_tot, &
    166166                                    stradar%lidar_only_freq_cloud,stradar%radar_lidar_tcc)
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/mod_cosp_utils.F90

    r5160 r5185  
    8585                        mxratio(i,j,k)=mxratio(i,j,k)/rho
    8686                        ! Compute effective radius
    87 !                        if ((reff(i,j,k) <= 0.0).and.(flux(i,k) /= 0.0)) then
    88                         if ((reff(i,j,k) <= 0.0).and.(flux(i,k) > seuil)) then
     87!                        if ((reff(i,j,k) <= 0.0).AND.(flux(i,k) /= 0.0)) then
     88                        if ((reff(i,j,k) <= 0.0).AND.(flux(i,k) > seuil)) then
    8989                           lambda_x = (a_x*c_x*((rho0/rho)**g_x)*n_ax*gamma1/flux(i,k))**(1./delta)
    9090                           reff(i,j,k) = gamma_4_3_2/lambda_x
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/mod_llnl_stats.F90

    r5158 r5185  
    7272            if (x(i,k,j) == R_GROUND) then
    7373               cosp_cfad(i,:,j) = R_UNDEF
    74             elseif ((x(i,k,j) >= xmin) .and. (x(i,k,j) <= xmax)) then
     74            elseif ((x(i,k,j) >= xmin) .AND. (x(i,k,j) <= xmax)) then
    7575               ibin = ceiling((x(i,k,j) - bmin)/bwidth)
    7676               if (ibin > Nbins) ibin = Nbins
     
    8181      enddo  !k
    8282   enddo  !j
    83    where ((cosp_cfad /= R_UNDEF).and.(cosp_cfad /= 0.0)) cosp_cfad = cosp_cfad / Ncolumns
     83   where ((cosp_cfad /= R_UNDEF).AND.(cosp_cfad /= 0.0)) cosp_cfad = cosp_cfad / Ncolumns
    8484END FUNCTION COSP_CFAD
    8585
     
    117117       DO j=Nlevels,1,-1 !top->surf
    118118        sc_ratio = beta_tot(pr,i,j)/beta_mol(pr,j)
    119         if ((sc_ratio .le. s_att) .and. (flag_sat .eq. 0)) flag_sat = j
     119        if ((sc_ratio .le. s_att) .AND. (flag_sat .eq. 0)) flag_sat = j
    120120        if (Ze_tot(pr,i,j) .lt. -30.) then  !radar can't detect cloud
    121121         if ( (sc_ratio .gt. s_cld) .or. (flag_sat .eq. j) ) then  !lidar sense cloud
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/mod_lmd_ipsl_stats.F90

    r5160 r5185  
    146146      DO ic = 1, ncol
    147147        pnorm_c = pnorm(:,ic,:)
    148         where ((pnorm_c.lt.xmax) .and. (pmol.lt.xmax) .and. (pmol.gt. 0.0 ))
     148        where ((pnorm_c.lt.xmax) .AND. (pmol.lt.xmax) .AND. (pmol.gt. 0.0 ))
    149149            x3d_c = pnorm_c/pmol
    150150        elsewhere
     
    273273               DO i = 1, Npoints
    274274                  if (x(i,k,j) /= undef) then
    275                      if ((x(i,k,j).gt.srbval_ext(ib-1)).and.(x(i,k,j).le.srbval_ext(ib))) &
     275                     if ((x(i,k,j).gt.srbval_ext(ib-1)).AND.(x(i,k,j).le.srbval_ext(ib))) &
    276276                          cfad(i,ib,j) = cfad(i,ib,j) + 1.0
    277277                  else
     
    421421
    422422! cloud detection at subgrid-scale:
    423          where ( (x(:,:,k).gt.S_cld) .and. (x(:,:,k).ne. undef) )
     423         where ( (x(:,:,k).gt.S_cld) .AND. (x(:,:,k).ne. undef) )
    424424           cldy(:,:,k)=1.0
    425425         elsewhere
     
    428428
    429429! number of usefull sub-columns:
    430          where ( (x(:,:,k).gt.S_att) .and. (x(:,:,k).ne. undef)  )
     430         where ( (x(:,:,k).gt.S_att) .AND. (x(:,:,k).ne. undef)  )
    431431           srok(:,:,k)=1.0
    432432         elsewhere
     
    462462           ! instead of height, for ice,liquid and all clouds
    463463           DO itemp=1,Ntemp
    464              if( (tmp(ip,k).ge.tempmod(itemp)).and.(tmp(ip,k).lt.tempmod(itemp+1)) )then
     464             if( (tmp(ip,k).ge.tempmod(itemp)).AND.(tmp(ip,k).lt.tempmod(itemp+1)) )then
    465465               lidarcldtempind(ip,itemp)=lidarcldtempind(ip,itemp)+1.
    466466             endif
     
    470470         if (cldy(ip,ic,k).eq.1.) then
    471471           DO itemp=1,Ntemp
    472              if( (tmp(ip,k).ge.tempmod(itemp)).and.(tmp(ip,k).lt.tempmod(itemp+1)) )then
     472             if( (tmp(ip,k).ge.tempmod(itemp)).AND.(tmp(ip,k).lt.tempmod(itemp+1)) )then
    473473               lidarcldtemp(ip,itemp,1)=lidarcldtemp(ip,itemp,1)+1.
    474474             endif
     
    478478         p1 = pplay(ip,k)
    479479
    480          if ( p1.gt.0. .and. p1.lt.(440.*100.)) then ! high clouds
     480         if ( p1.gt.0. .AND. p1.lt.(440.*100.)) then ! high clouds
    481481            cldlay3(ip,ic) = MAX(cldlay3(ip,ic), cldy(ip,ic,k))
    482482            nsublay3(ip,ic) = MAX(nsublay3(ip,ic), srok(ip,ic,k))
    483          else if(p1.ge.(440.*100.) .and. p1.lt.(680.*100.)) then  ! mid clouds
     483         else if(p1.ge.(440.*100.) .AND. p1.lt.(680.*100.)) then  ! mid clouds
    484484            cldlay2(ip,ic) = MAX(cldlay2(ip,ic), cldy(ip,ic,k))
    485485            nsublay2(ip,ic) = MAX(nsublay2(ip,ic), srok(ip,ic,k))
     
    513513          if(srok(ip,ic,k).gt.0.)then
    514514          DO itemp=1,Ntemp
    515             if( (tmp(ip,k).ge.tempmod(itemp)).and.(tmp(ip,k).lt.tempmod(itemp+1)) )then
     515            if( (tmp(ip,k).ge.tempmod(itemp)).AND.(tmp(ip,k).lt.tempmod(itemp+1)) )then
    516516              lidarcldtempind(ip,itemp)=lidarcldtempind(ip,itemp)+1.
    517517            endif
     
    521521          if(cldy(ip,ic,k).eq.1.)then
    522522          DO itemp=1,Ntemp
    523             if( (tmp(ip,k).ge.tempmod(itemp)).and.(tmp(ip,k).lt.tempmod(itemp+1)) )then
     523            if( (tmp(ip,k).ge.tempmod(itemp)).AND.(tmp(ip,k).lt.tempmod(itemp+1)) )then
    524524              lidarcldtemp(ip,itemp,1)=lidarcldtemp(ip,itemp,1)+1.
    525525            endif
     
    529529          iz=1
    530530          p1 = pplay(ip,k)
    531           if ( p1.gt.0. .and. p1.lt.(440.*100.)) then ! high clouds
     531          if ( p1.gt.0. .AND. p1.lt.(440.*100.)) then ! high clouds
    532532            iz=3
    533           else if(p1.ge.(440.*100.) .and. p1.lt.(680.*100.)) then  ! mid clouds
     533          else if(p1.ge.(440.*100.) .AND. p1.lt.(680.*100.)) then  ! mid clouds
    534534            iz=2
    535535         endif
     
    590590
    591591! Avoid zero values
    592     if( (cldy(i,ncol,nlev).eq.1.) .and. (ATBperp(i,ncol,nlev).gt.0.) )then
     592    if( (cldy(i,ncol,nlev).eq.1.) .AND. (ATBperp(i,ncol,nlev).gt.0.) )then
    593593! Computation of the ATBperp along the phase discrimination line
    594594           ATBperp_tmp = (ATB(i,ncol,nlev)**5)*alpha50 + (ATB(i,ncol,nlev)**4)*beta50 + &
     
    610610                                                    ! to classify the phase cloud
    611611                cldlayphase(i,ncol,4,2) = 1.                         ! tot cloud
    612                 if ( p1.gt.0. .and. p1.lt.(440.*100.)) then             ! high cloud
     612                if ( p1.gt.0. .AND. p1.lt.(440.*100.)) then             ! high cloud
    613613               cldlayphase(i,ncol,3,2) = 1.
    614              else if(p1.ge.(440.*100.) .and. p1.lt.(680.*100.)) then ! mid cloud
     614             else if(p1.ge.(440.*100.) .AND. p1.lt.(680.*100.)) then ! mid cloud
    615615                cldlayphase(i,ncol,2,2) = 1.
    616616         else                                                    ! low cloud
     
    618618                endif
    619619                cldlayphase(i,ncol,4,5) = 1.                         ! tot cloud
    620              if ( p1.gt.0. .and. p1.lt.(440.*100.)) then             ! high cloud
     620             if ( p1.gt.0. .AND. p1.lt.(440.*100.)) then             ! high cloud
    621621               cldlayphase(i,ncol,3,5) = 1.
    622              else if(p1.ge.(440.*100.) .and. p1.lt.(680.*100.)) then ! mid cloud
     622             else if(p1.ge.(440.*100.) .AND. p1.lt.(680.*100.)) then ! mid cloud
    623623                cldlayphase(i,ncol,2,5) = 1.
    624624         else                                                    ! low cloud
     
    631631              tmpi(i,ncol,nlev)=tmp(i,nlev)
    632632                cldlayphase(i,ncol,4,1) = 1.                         ! tot cloud
    633              if ( p1.gt.0. .and. p1.lt.(440.*100.)) then             ! high cloud
     633             if ( p1.gt.0. .AND. p1.lt.(440.*100.)) then             ! high cloud
    634634               cldlayphase(i,ncol,3,1) = 1.
    635              else if(p1.ge.(440.*100.) .and. p1.lt.(680.*100.)) then ! mid cloud
     635             else if(p1.ge.(440.*100.) .AND. p1.lt.(680.*100.)) then ! mid cloud
    636636                cldlayphase(i,ncol,2,1) = 1.
    637637         else                                                    ! low cloud
     
    652652               tmpl(i,ncol,nlev)=tmp(i,nlev)
    653653                cldlayphase(i,ncol,4,2) = 1.                         ! tot cloud
    654              if ( p1.gt.0. .and. p1.lt.(440.*100.)) then             ! high cloud
     654             if ( p1.gt.0. .AND. p1.lt.(440.*100.)) then             ! high cloud
    655655                cldlayphase(i,ncol,3,2) = 1.
    656              else if(p1.ge.(440.*100.) .and. p1.lt.(680.*100.)) then ! mid cloud
     656             else if(p1.ge.(440.*100.) .AND. p1.lt.(680.*100.)) then ! mid cloud
    657657                cldlayphase(i,ncol,2,2) = 1.
    658658         else                                                    ! low cloud
     
    667667                                                    ! to classify the phase cloud
    668668                cldlayphase(i,ncol,4,4) = 1.                         ! tot cloud
    669              if ( p1.gt.0. .and. p1.lt.(440.*100.)) then             ! high cloud
     669             if ( p1.gt.0. .AND. p1.lt.(440.*100.)) then             ! high cloud
    670670                cldlayphase(i,ncol,3,4) = 1.
    671              else if(p1.ge.(440.*100.) .and. p1.lt.(680.*100.)) then ! mid cloud
     671             else if(p1.ge.(440.*100.) .AND. p1.lt.(680.*100.)) then ! mid cloud
    672672                cldlayphase(i,ncol,2,4) = 1.
    673673         else                                                    ! low cloud
     
    675675         endif
    676676                cldlayphase(i,ncol,4,1) = 1.                         ! tot cloud
    677             if ( p1.gt.0. .and. p1.lt.(440.*100.)) then             ! high cloud
     677            if ( p1.gt.0. .AND. p1.lt.(440.*100.)) then             ! high cloud
    678678                cldlayphase(i,ncol,3,1) = 1.
    679              else if(p1.ge.(440.*100.) .and. p1.lt.(680.*100.)) then ! mid cloud
     679             else if(p1.ge.(440.*100.) .AND. p1.lt.(680.*100.)) then ! mid cloud
    680680                cldlayphase(i,ncol,2,1) = 1.
    681681         else                                                    ! low cloud
     
    699699         p1 = pplay(i,nlev)
    700700
    701     if( (cldy(i,ncol,nlev).eq.1.) .and. (ATBperp(i,ncol,nlev).gt.0.) )then
     701    if( (cldy(i,ncol,nlev).eq.1.) .AND. (ATBperp(i,ncol,nlev).gt.0.) )then
    702702! Phase discrimination line : ATBperp = ATB^5*alpha50 + ATB^4*beta50 + ATB^3*gamma50 + ATB^2*delta50
    703703!                                  + ATB*epsilon50 + zeta50
     
    719719
    720720                cldlayphase(i,ncol,4,2) = 1.                         ! tot cloud
    721                if ( p1.gt.0. .and. p1.lt.(440.*100.)) then              ! high cloud
     721               if ( p1.gt.0. .AND. p1.lt.(440.*100.)) then              ! high cloud
    722722               cldlayphase(i,ncol,3,2) = 1.
    723              else if(p1.ge.(440.*100.) .and. p1.lt.(680.*100.)) then ! mid cloud
     723             else if(p1.ge.(440.*100.) .AND. p1.lt.(680.*100.)) then ! mid cloud
    724724                cldlayphase(i,ncol,2,2) = 1.
    725725         else                                                    ! low cloud
     
    728728
    729729                cldlayphase(i,ncol,4,5) = 1.                         ! tot cloud
    730              if ( p1.gt.0. .and. p1.lt.(440.*100.)) then             ! high cloud
     730             if ( p1.gt.0. .AND. p1.lt.(440.*100.)) then             ! high cloud
    731731               cldlayphase(i,ncol,3,5) = 1.
    732              else if(p1.ge.(440.*100.) .and. p1.lt.(680.*100.)) then ! mid cloud
     732             else if(p1.ge.(440.*100.) .AND. p1.lt.(680.*100.)) then ! mid cloud
    733733                cldlayphase(i,ncol,2,5) = 1.
    734734         else                                                    ! low cloud
     
    742742
    743743                 cldlayphase(i,ncol,4,1) = 1.                         ! tot cloud
    744             if ( p1.gt.0. .and. p1.lt.(440.*100.)) then             ! high cloud
     744            if ( p1.gt.0. .AND. p1.lt.(440.*100.)) then             ! high cloud
    745745               cldlayphase(i,ncol,3,1) = 1.
    746              else if(p1.ge.(440.*100.) .and. p1.lt.(680.*100.)) then ! mid cloud
     746             else if(p1.ge.(440.*100.) .AND. p1.lt.(680.*100.)) then ! mid cloud
    747747                cldlayphase(i,ncol,2,1) = 1.
    748748         else                                                    ! low cloud
     
    764764
    765765                cldlayphase(i,ncol,4,2) = 1.                         ! tot cloud
    766              if ( p1.gt.0. .and. p1.lt.(440.*100.)) then             ! high cloud
     766             if ( p1.gt.0. .AND. p1.lt.(440.*100.)) then             ! high cloud
    767767                cldlayphase(i,ncol,3,2) = 1.
    768              else if(p1.ge.(440.*100.) .and. p1.lt.(680.*100.)) then ! mid cloud
     768             else if(p1.ge.(440.*100.) .AND. p1.lt.(680.*100.)) then ! mid cloud
    769769                cldlayphase(i,ncol,2,2) = 1.
    770770         else                                                    ! low cloud
     
    779779
    780780                cldlayphase(i,ncol,4,4) = 1.                         ! tot cloud
    781              if ( p1.gt.0. .and. p1.lt.(440.*100.)) then             ! high cloud
     781             if ( p1.gt.0. .AND. p1.lt.(440.*100.)) then             ! high cloud
    782782                cldlayphase(i,ncol,3,4) = 1.
    783              else if(p1.ge.(440.*100.) .and. p1.lt.(680.*100.)) then ! mid cloud
     783             else if(p1.ge.(440.*100.) .AND. p1.lt.(680.*100.)) then ! mid cloud
    784784                cldlayphase(i,ncol,2,4) = 1.
    785785         else                                                    ! low cloud
     
    788788
    789789                cldlayphase(i,ncol,4,1) = 1.                         ! tot cloud
    790             if ( p1.gt.0. .and. p1.lt.(440.*100.)) then             ! high cloud
     790            if ( p1.gt.0. .AND. p1.lt.(440.*100.)) then             ! high cloud
    791791                cldlayphase(i,ncol,3,1) = 1.
    792              else if(p1.ge.(440.*100.) .and. p1.lt.(680.*100.)) then ! mid cloud
     792             else if(p1.ge.(440.*100.) .AND. p1.lt.(680.*100.)) then ! mid cloud
    793793                cldlayphase(i,ncol,2,1) = 1.
    794794         else                                                    ! low cloud
     
    826826
    827827                cldlayphase(i,ncol,4,3) = 1.                         ! tot cloud
    828           if ( p1.gt.0. .and. p1.lt.(440.*100.)) then              ! high cloud
     828          if ( p1.gt.0. .AND. p1.lt.(440.*100.)) then              ! high cloud
    829829             cldlayphase(i,ncol,3,3) = 1.
    830           else if(p1.ge.(440.*100.) .and. p1.lt.(680.*100.)) then  ! mid cloud
     830          else if(p1.ge.(440.*100.) .AND. p1.lt.(680.*100.)) then  ! mid cloud
    831831             cldlayphase(i,ncol,2,3) = 1.
    832832      else                                                     ! low cloud
     
    939939DO itemp=1,Ntemp
    940940if(tmpi(i,ncol,nlev).gt.0.)then
    941       if( (tmpi(i,ncol,nlev).ge.tempmod(itemp)).and.(tmpi(i,ncol,nlev).lt.tempmod(itemp+1)) )then
     941      if( (tmpi(i,ncol,nlev).ge.tempmod(itemp)).AND.(tmpi(i,ncol,nlev).lt.tempmod(itemp+1)) )then
    942942        lidarcldtemp(i,itemp,2)=lidarcldtemp(i,itemp,2)+1.
    943943      endif
    944944elseif(tmpl(i,ncol,nlev).gt.0.)then
    945       if( (tmpl(i,ncol,nlev).ge.tempmod(itemp)).and.(tmpl(i,ncol,nlev).lt.tempmod(itemp+1)) )then
     945      if( (tmpl(i,ncol,nlev).ge.tempmod(itemp)).AND.(tmpl(i,ncol,nlev).lt.tempmod(itemp+1)) )then
    946946        lidarcldtemp(i,itemp,3)=lidarcldtemp(i,itemp,3)+1.
    947947      endif
    948948elseif(tmpu(i,ncol,nlev).gt.0.)then
    949       if( (tmpu(i,ncol,nlev).ge.tempmod(itemp)).and.(tmpu(i,ncol,nlev).lt.tempmod(itemp+1)) )then
     949      if( (tmpu(i,ncol,nlev).ge.tempmod(itemp)).AND.(tmpu(i,ncol,nlev).lt.tempmod(itemp+1)) )then
    950950        lidarcldtemp(i,itemp,4)=lidarcldtemp(i,itemp,4)+1.
    951951      endif
     
    10421042    DO k=1,Nlevels
    10431043       ! Cloud detection at subgrid-scale:
    1044        where ( (x(:,:,k) .gt. S_cld) .and. (x(:,:,k) .ne. undef) )
     1044       where ( (x(:,:,k) .gt. S_cld) .AND. (x(:,:,k) .ne. undef) )
    10451045          cldy(:,:,k)=1.0
    10461046       elsewhere
     
    10481048       endwhere
    10491049       ! Fully attenuated layer detection at subgrid-scale:
    1050        where ( (x(:,:,k) .gt. 0.0) .and. (x(:,:,k) .lt. S_att_opaq) .and. (x(:,:,k) .ne. undef) )
     1050       where ( (x(:,:,k) .gt. 0.0) .AND. (x(:,:,k) .lt. S_att_opaq) .AND. (x(:,:,k) .ne. undef) )
    10511051          cldyopaq(:,:,k)=1.0
    10521052       elsewhere
     
    10551055
    10561056       ! Number of useful sub-column layers:
    1057        where ( (x(:,:,k) .gt. S_att) .and. (x(:,:,k) .ne. undef) )
     1057       where ( (x(:,:,k) .gt. S_att) .AND. (x(:,:,k) .ne. undef) )
    10581058          srok(:,:,k)=1.0
    10591059       elsewhere
     
    10611061       endwhere
    10621062       ! Number of useful sub-columns layers for z_opaque 3D fraction:
    1063        where ( (x(:,:,k) .gt. 0.0) .and. (x(:,:,k) .ne. undef) )
     1063       where ( (x(:,:,k) .gt. 0.0) .AND. (x(:,:,k) .ne. undef) )
    10641064          srokopaq(:,:,k)=1.0
    10651065       elsewhere
     
    10941094
    10951095     ! Declaring non-opaque cloudy profiles as thin cloud profiles
    1096        if ( (cldlay(ip,ic,4) .eq. 1.0) .and. (cldlay(ip,ic,1) .eq. 0.0) ) then
     1096       if ( (cldlay(ip,ic,4) .eq. 1.0) .AND. (cldlay(ip,ic,1) .eq. 0.0) ) then
    10971097          cldlay(ip,ic,2)  =  1.0
    10981098        endif
     
    11051105          DO k=2,Nlevels
    11061106     ! Declaring opaque cloud fraction and z_opaque altitude for 3D and 2D variables
    1107              if ( (cldy(ip,ic,k) .eq. 1.0) .and. (zopac .eq. 0.0) ) then
     1107             if ( (cldy(ip,ic,k) .eq. 1.0) .AND. (zopac .eq. 0.0) ) then
    11081108            lidarcldtype(ip,k-1,3) = lidarcldtype(ip,k-1,3) + 1.0
    11091109            cldlay(ip,ic,3)        = vgrid_z(k-1) !z_opaque altitude
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/mod_modis_sim.F90

    r5158 r5185  
    249249    ! Initialize initial estimates for size retrievals
    250250
    251     if(any(cloudMask) .and. .not. useSimpleReScheme) then
     251    if(any(cloudMask) .AND. .not. useSimpleReScheme) then
    252252      g_w(:)  = get_g_nir(  phaseIsLiquid, trial_re_w(:))
    253253      w0_w(:) = get_ssa_nir(phaseIsLiquid, trial_re_w(:))
     
    319319      end if
    320320    end do
    321     where((retrievedSize(:) < 0.).and.(retrievedSize(:) /= R_UNDEF)) retrievedSize(:) = 1.0e-06*re_fill
     321    where((retrievedSize(:) < 0.).AND.(retrievedSize(:) /= R_UNDEF)) retrievedSize(:) = 1.0e-06*re_fill
    322322
    323323    ! We use the ISCCP-derived CTP for low clouds, since the ISCCP simulator ICARUS
     
    325325    !   Of course, ISCCP cloud top pressures are in mb.
    326326
    327     where(cloudMask(:) .and. retrievedCloudTopPressure(:) > CO2Slicing_PressureLimit) &
     327    where(cloudMask(:) .AND. retrievedCloudTopPressure(:) > CO2Slicing_PressureLimit) &
    328328      retrievedCloudTopPressure(:) = isccpCloudTopPressure * 100.
    329329   
     
    475475    ! ########################################################################################
    476476    validRetrievalMask(1:nPoints,1:nSubCols) = particle_size(1:nPoints,1:nSubCols) > 0.
    477     cloudMask(1:nPoints,1:nSubCols) = phase(1:nPoints,1:nSubCols) /= phaseIsNone .and.       &
     477    cloudMask(1:nPoints,1:nSubCols) = phase(1:nPoints,1:nSubCols) /= phaseIsNone .AND.       &
    478478         validRetrievalMask(1:nPoints,1:nSubCols)
    479     waterCloudMask(1:nPoints,1:nSubCols) = phase(1:nPoints,1:nSubCols) == phaseIsLiquid .and. &
     479    waterCloudMask(1:nPoints,1:nSubCols) = phase(1:nPoints,1:nSubCols) == phaseIsLiquid .AND. &
    480480         validRetrievalMask(1:nPoints,1:nSubCols)
    481     iceCloudMask(1:nPoints,1:nSubCols)   = phase(1:nPoints,1:nSubCols) == phaseIsIce .and.    &
     481    iceCloudMask(1:nPoints,1:nSubCols)   = phase(1:nPoints,1:nSubCols) == phaseIsIce .AND.    &
    482482         validRetrievalMask(1:nPoints,1:nSubCols)
    483483
     
    488488    Cloud_Fraction_Water_Mean(1:nPoints) = real(count(waterCloudMask, dim = 2))
    489489    Cloud_Fraction_Ice_Mean(1:nPoints)   = real(count(iceCloudMask,   dim = 2))
    490     Cloud_Fraction_High_Mean(1:nPoints)  = real(count(cloudMask .and. cloud_top_pressure <=          &
     490    Cloud_Fraction_High_Mean(1:nPoints)  = real(count(cloudMask .AND. cloud_top_pressure <=          &
    491491                                           highCloudPressureLimit, dim = 2))
    492     Cloud_Fraction_Low_Mean(1:nPoints)   = real(count(cloudMask .and. cloud_top_pressure >           &
     492    Cloud_Fraction_Low_Mean(1:nPoints)   = real(count(cloudMask .AND. cloud_top_pressure >           &
    493493                                           lowCloudPressureLimit,  dim = 2))
    494494    Cloud_Fraction_Mid_Mean(1:nPoints)   = Cloud_Fraction_Total_Mean(1:nPoints) - Cloud_Fraction_High_Mean(1:nPoints)&
     
    653653    DO ij=2,nbin1+1
    654654       DO ik=2,nbin2+1
    655           jointHist(ij-1,ik-1)=count(var1 .ge. bin1(ij-1) .and. var1 .lt. bin1(ij) .and. &
    656                var2 .ge. bin2(ik-1) .and. var2 .lt. bin2(ik))       
     655          jointHist(ij-1,ik-1)=count(var1 .ge. bin1(ij-1) .AND. var1 .lt. bin1(ij) .AND. &
     656               var2 .ge. bin2(ik-1) .AND. var2 .lt. bin2(ik))
    657657       enddo
    658658    enddo
     
    719719
    720720    validRetrievalMask(:, :) = particle_size(:, :) > 0.
    721     cloudMask      = phase(:, :) /= phaseIsNone   .and. validRetrievalMask(:, :)
    722     waterCloudMask = phase(:, :) == phaseIsLiquid .and. validRetrievalMask(:, :)
    723     iceCloudMask   = phase(:, :) == phaseIsIce    .and. validRetrievalMask(:, :)
     721    cloudMask      = phase(:, :) /= phaseIsNone   .AND. validRetrievalMask(:, :)
     722    waterCloudMask = phase(:, :) == phaseIsLiquid .AND. validRetrievalMask(:, :)
     723    iceCloudMask   = phase(:, :) == phaseIsIce    .AND. validRetrievalMask(:, :)
    724724
    725725    ! Use these as pixel counts at first
     
    729729    Cloud_Fraction_Ice_Mean(:)   = real(count(iceCloudMask,   dim = 2))
    730730   
    731     Cloud_Fraction_High_Mean(:) = real(count(cloudMask .and. cloud_top_pressure <= highCloudPressureLimit, dim = 2))
    732     Cloud_Fraction_Low_Mean(:)  = real(count(cloudMask .and. cloud_top_pressure >  lowCloudPressureLimit,  dim = 2))
     731    Cloud_Fraction_High_Mean(:) = real(count(cloudMask .AND. cloud_top_pressure <= highCloudPressureLimit, dim = 2))
     732    Cloud_Fraction_Low_Mean(:)  = real(count(cloudMask .AND. cloud_top_pressure >  lowCloudPressureLimit,  dim = 2))
    733733    Cloud_Fraction_Mid_Mean(:)  = Cloud_Fraction_Total_Mean(:) - Cloud_Fraction_High_Mean(:) - Cloud_Fraction_Low_Mean(:)
    734734
     
    780780    DO i = 1, numTauHistogramBins
    781781      where(cloudMask(:, :))
    782         tauMask(:, :, i) = optical_thickness(:, :) >= tauHistogramBoundaries(i) .and. &
     782        tauMask(:, :, i) = optical_thickness(:, :) >= tauHistogramBoundaries(i) .AND. &
    783783                           optical_thickness(:, :) <  tauHistogramBoundaries(i+1)
    784784      elsewhere
     
    789789    DO i = 1, numPressureHistogramBins
    790790      where(cloudMask(:, :))
    791         pressureMask(:, :, i) = cloud_top_pressure(:, :) >= pressureHistogramBoundaries(i) .and. &
     791        pressureMask(:, :, i) = cloud_top_pressure(:, :) >= pressureHistogramBoundaries(i) .AND. &
    792792                                cloud_top_pressure(:, :) <  pressureHistogramBoundaries(i+1)
    793793      elsewhere
     
    799799      DO j = 1, numTauHistogramBins
    800800        Optical_Thickness_vs_Cloud_Top_Pressure(:, j, i) = &
    801           real(count(tauMask(:, :, j) .and. pressureMask(:, :, i), dim = 2)) / real(nSubcols)
     801          real(count(tauMask(:, :, j) .AND. pressureMask(:, :, i), dim = 2)) / real(nSubcols)
    802802      end do
    803803    end do
     
    936936
    937937! DJS2015: Remove unused piece of code     
    938 !      if(use_two_re_iterations .and. retrieve_re > 0.) then
     938!      if(use_two_re_iterations .AND. retrieve_re > 0.) then
    939939!        re_min = retrieve_re - delta_re
    940940!        re_max = retrieve_re + delta_re
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/phys_cosp.F90

    r5160 r5185  
    201201
    202202!!! Ici on modifie les cles logiques pour les outputs selon les champs actives dans les .xml
    203   if ((itap.gt.1).and.(first_write))then
     203  if ((itap.gt.1).AND.(first_write))then
    204204   
    205205    IF (using_xios) call read_xiosfieldactive(cfg)
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/prec_scops.F

    r5099 r5185  
    192192          endif
    193193        enddo ! loop over ncol
    194         if ((flag_ls .eq. 0) .and. (ilev .lt. nlev)) then ! possibility THREE
     194        if ((flag_ls .eq. 0) .AND. (ilev .lt. nlev)) then ! possibility THREE
    195195        do ibox=1,ncol
    196196        if (frac_out(j,ibox,ilev+1) .eq. 1) then
     
    229229        endif
    230230       enddo ! loop over ncol
    231         if ((flag_cv .eq. 0) .and. (ilev .lt. nlev)) then ! possibility THREE
     231        if ((flag_cv .eq. 0) .AND. (ilev .lt. nlev)) then ! possibility THREE
    232232        do ibox=1,ncol
    233233        if (frac_out(j,ibox,ilev+1) .eq. 2) then
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/radar_simulator.F90

    r5160 r5185  
    187187      hydro = .false.
    188188      DO j=1,hp%nhclass
    189         if ((hm_matrix(j,pr,k) > 1E-12) .and. (hp%dtype(j) > 0)) then
     189        if ((hm_matrix(j,pr,k) > 1E-12) .AND. (hp%dtype(j) > 0)) then
    190190          hydro = .true.
    191191          exit
     
    298298            else
    299299              ! I assume here that water phase droplets are spheres.
    300               ! hp%rho should be ~ 1000  or hp%apm=524 .and. hp%bpm=3
     300              ! hp%rho should be ~ 1000  or hp%apm=524 .AND. hp%bpm=3
    301301              Deq = Di
    302302            endif
     
    311311            ! NOTE: if .not. DO_LUT_TEST, then you are checking the LUT approximation
    312312            ! not just the DSD representation given by Ni
    313             if(Np_matrix(tp,pr,k)>0 .and. DO_NP_TEST ) then
     313            if(Np_matrix(tp,pr,k)>0 .AND. DO_NP_TEST ) then
    314314              Np = path_integral(Ni,Di,1,ns-1)/rho_a*1E6
    315315              ! Note: Representation is not great or small Re < 2
     
    326326            ! LUT test code
    327327            ! This segment of code compares full calculation to scaling result
    328             if ( hp%Z_scale_flag(tp,itt,iRe_type) .and. DO_LUT_TEST )  then
     328            if ( hp%Z_scale_flag(tp,itt,iRe_type) .AND. DO_LUT_TEST )  then
    329329              scale_factor=rho_a*hm_matrix(tp,pr,k)
    330330              ! if more than 2 dBZe difference print error message/parameters.
     
    400400        g_to_vol(pr,k) = g_to_vol_in(pr,k)
    401401      else
    402         if ( (hp%use_gas_abs == 1) .or. ((hp%use_gas_abs == 2) .and. (pr == 1)) ) then
     402        if ( (hp%use_gas_abs == 1) .or. ((hp%use_gas_abs == 2) .AND. (pr == 1)) ) then
    403403          g_vol(pr,k) = gases(p_matrix(pr,k),t_kelvin,rh_matrix(pr,k),hp%freq)
    404404          if (d_gate==1) then
     
    428428
    429429      ! Compute Rayleigh reflectivity, and full, attenuated reflectivity
    430       if ((hp%do_ray == 1) .and. (z_ray(pr,k) > 0)) then
     430      if ((hp%do_ray == 1) .AND. (z_ray(pr,k) > 0)) then
    431431        Ze_ray(pr,k) = 10*log10(z_ray(pr,k))
    432432      else
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/scops.F

    r5099 r5185  
    236236              if (threshold(j,ibox)
    237237     &          .lt.min(tca(j,ilev-1),tca(j,ilev))
    238      &          .and.(threshold(j,ibox).gt.conv(j,ilev))) then
     238     &          .AND.(threshold(j,ibox).gt.conv(j,ilev))) then
    239239                   maxosc(j,ibox)= 1
    240240              else
  • LMDZ6/branches/Amaury_dev/libf/phylmd/cosp/zeff.F90

    r5158 r5185  
    9999   
    100100    correct_for_rho = 0
    101     if ((ice == 1) .and. (minval(rho_e) >= 0)) correct_for_rho = 1
     101    if ((ice == 1) .AND. (minval(rho_e) >= 0)) correct_for_rho = 1
    102102   
    103103!   :: correct refractive index for ice density if needed
Note: See TracChangeset for help on using the changeset viewer.