Changeset 4144 for palm


Ignore:
Timestamp:
Aug 6, 2019 9:11:47 AM (5 years ago)
Author:
raasch
Message:

relational operators .EQ., .NE., etc. replaced by ==, /=, etc.

Location:
palm/trunk/SOURCE
Files:
10 edited

Legend:

Unmodified
Added
Removed
  • palm/trunk/SOURCE/biometeorology_mod.f90

    r4127 r4144  
    2727! -----------------
    2828! $Id$
     29! relational operators .EQ., .NE., etc. replaced by ==, /=, etc.
     30!
     31! 4127 2019-07-30 14:47:10Z suehring
    2932! Output for bio_mrt added (merge from branch resler)
    3033!
     
    43194322!
    43204323!-- calculation of solar azimuth angle
    4321     IF (woz .LE. 12.0_wp) alpha = pi - acos( ( sin(thetasr) * sin( lat * dtor ) -                                     &
     4324    IF (woz <= 12.0_wp) alpha = pi - acos( ( sin(thetasr) * sin( lat * dtor ) -                                     &
    43224325    sin( declination * dtor ) ) / ( cos(thetasr) * cos( lat * dtor ) ) )   
    4323     IF (woz .GT. 12.0_wp) alpha = pi + acos( ( sin(thetasr) * sin( lat * dtor ) -                                     &
     4326    IF (woz > 12.0_wp) alpha = pi + acos( ( sin(thetasr) * sin( lat * dtor ) -                                     &
    43244327    sin( declination * dtor ) ) / ( cos(thetasr) * cos( lat * dtor ) ) )   
    43254328    saa = alpha / dtor
     
    43474350    CALL uvem_solar_position
    43484351     
    4349     IF (sza  .GE.  90)  THEN
     4352    IF (sza  >=  90)  THEN
    43504353       vitd3_exposure(:,:) = 0.0_wp
    43514354    ELSE
     
    44464449             IF (consider_obstructions )  THEN
    44474450                obstruction_temp1 = building_obstruction_f%var_3d(:,j,i)
    4448                 IF (obstruction_temp1(0)  .NE.  9)  THEN
     4451                IF ( obstruction_temp1(0)  /=  9 )  THEN
    44494452                   DO  pobi = 0, 44
    44504453                      DO  bi = 0, 7
     
    44684471         
    44694472             obstruction_direct_beam = obstruction( nint(startpos_saa_float), nint( sza / 10.0_wp ) )
    4470              IF (sza  .GE.  89.99_wp)  THEN
     4473             IF (sza  >=  89.99_wp)  THEN
    44714474                sza = 89.99999_wp
    44724475             ENDIF
  • palm/trunk/SOURCE/chem_emissions_mod.f90

    r4055 r4144  
    2727! -----------------
    2828! $Id$
     29! relational operators .EQ., .NE., etc. replaced by ==, /=, etc.
     30!
     31! 4055 2019-06-27 09:47:29Z suehring
    2932! - replaced local thermo. constants w/ module definitions in
    3033!   basic_constants_and_equations_mod (rgas_univ, p_0, r_d_cp)
     
    724727                END DO     ! ind_mod
    725728
    726              ELSE  ! if len_index_voc .le. 0
     729             ELSE  ! if len_index_voc <= 0
    727730
    728731!
  • palm/trunk/SOURCE/date_and_time_mod.f90

    r3839 r4144  
    2525! -----------------
    2626! $Id$
     27! relational operators .EQ., .NE., etc. replaced by ==, /=, etc.
     28!
     29! 3839 2019-03-28 21:12:25Z moh.hefny
    2730! further tabs removed, unused variables removed
    2831!
     
    191194
    192195          !> Condition for printing an error when date_init is not provided when day_of_year_init is not given in the namelist or when the format of the date is not the one required by PALM.
    193           IF ( day_of_month .GT. 0 .AND. day_of_month .LE. 31 .AND. month_of_year .GT. 0 .AND. month_of_year .LE. 12) THEN
     196          IF ( day_of_month > 0 .AND. day_of_month <= 31 .AND. month_of_year > 0 .AND. month_of_year <= 12) THEN
    194197       
    195198             IF ( month_of_year == 1 ) THEN  !!month of year is read in input
     
    226229
    227230         
    228           IF ( day_of_year .LE. 31 ) THEN
     231          IF ( day_of_year <= 31 ) THEN
    229232
    230233             month_of_year=1
     
    234237
    235238             DO i_mon=2,12   !january is considered in the first case
    236                 IF ( day_of_year .LE. SUM(days(1:i_mon)) .AND. day_of_year .GT. SUM(days(1:(i_mon-1))) ) THEN
     239                IF ( day_of_year <= SUM(days(1:i_mon)) .AND. day_of_year > SUM(days(1:(i_mon-1))) ) THEN
    237240           
    238241                   month_of_year=i_mon
     
    249252       !> in the second condition both day of month and month_of_year are either given in input (passed to date_init) or we are in some day successive to the initial one, so that day_of_month has already be computed in previous step
    250253       !>TBD: something to calculate the current year is missing
    251        ELSEIF ( day_of_month .GT. 0 .AND. day_of_month .LE. 31 .AND. month_of_year .GT. 0 .AND. month_of_year .LE. 12) THEN
     254       ELSEIF ( day_of_month > 0 .AND. day_of_month <= 31 .AND. month_of_year > 0 .AND. month_of_year <= 12) THEN
    252255 
    253256          !> calculate month_of_year. TBD: test the condition when day_of_year==31
     
    257260             month_of_year = 1
    258261       
    259           ELSE IF (day_of_year .GT. 1 .AND. day_of_year .GT. SUM(days(1:month_of_year))) THEN
     262          ELSE IF (day_of_year > 1 .AND. day_of_year > SUM(days(1:month_of_year))) THEN
    260263
    261264             month_of_year = month_of_year + 1
     
    319322
    320323          !> Condition for printing an error when date_init is not provided when day_of_year_init is not given in the namelist or when the format of the date is not the one required by PALM.
    321           IF ( day_of_month .GT. 0 .AND. day_of_month .LE. 31 .AND. month_of_year .GT. 0 .AND. month_of_year .LE. 12) THEN
     324          IF ( day_of_month > 0 .AND. day_of_month <= 31 .AND. month_of_year > 0 .AND. month_of_year <= 12) THEN
    322325       
    323326             IF ( month_of_year == 1 ) THEN  !!month of year is read in input
     
    346349
    347350!--    Calculate current day of the year !TBD: considetr leap years
    348        IF ( (day_of_year_init + days_since_reference_point)  .GT. 365 ) THEN
     351       IF ( (day_of_year_init + days_since_reference_point)  > 365 ) THEN
    349352
    350353          day_of_year=INT(MOD((day_of_year_init + days_since_reference_point), 365.0_wp))
     
    369372          !> The first case is when date_init is not provided: we only know day_of_year_init
    370373          !DO i_mon=1,12
    371              !IF (day_of_year .LE. SUM(days(1:i_mon))) THEN
    372           IF ( day_of_year .LE. 31 ) THEN
     374             !IF (day_of_year <= SUM(days(1:i_mon))) THEN
     375          IF ( day_of_year <= 31 ) THEN
    373376
    374377             month_of_year=1
     
    378381
    379382             DO i_mon=2,12   !january is considered in the first case
    380                 IF ( day_of_year .LE. SUM(days(1:i_mon)) .AND. day_of_year .GT. SUM(days(1:(i_mon-1))) ) THEN
     383                IF ( day_of_year <= SUM(days(1:i_mon)) .AND. day_of_year > SUM(days(1:(i_mon-1))) ) THEN
    381384           
    382385                   month_of_year=i_mon
     
    393396       !> in the second condition both day of month and month_of_year are either given in input (passed to date_init) or we are in some day successive to the initial one, so that day_of_month has already be computed in previous step
    394397       !>TBD: something to calculate the current year is missing
    395        ELSEIF ( day_of_month .GT. 0 .AND. day_of_month .LE. 31 .AND. month_of_year .GT. 0 .AND. month_of_year .LE. 12) THEN
     398       ELSEIF ( day_of_month > 0 .AND. day_of_month <= 31 .AND. month_of_year > 0 .AND. month_of_year <= 12) THEN
    396399 
    397400          !> calculate month_of_year. TBD: test the condition when day_of_year==31
     
    401404             month_of_year = 1
    402405       
    403           ELSE IF (day_of_year .GT. 1 .AND. day_of_year .GT. SUM(days(1:month_of_year))) THEN
     406          ELSE IF (day_of_year > 1 .AND. day_of_year > SUM(days(1:month_of_year))) THEN
    404407
    405408             month_of_year = month_of_year + 1
  • palm/trunk/SOURCE/indoor_model_mod.f90

    r3885 r4144  
    2626! -----------------
    2727! $Id$
     28! relational operators .EQ., .NE., etc. replaced by ==, /=, etc.
     29!
     30! 3885 2019-04-11 11:29:34Z kanani
    2831! Changes related to global restructuring of location messages and introduction
    2932! of additional debug messages
     
    454457          IF ( building_id_f%var(j,i) /= building_id_f%fill )  THEN
    455458             IF ( num_buildings_l(myid) > 0 )  THEN
    456                 IF ( ANY( building_id_f%var(j,i) .EQ.  build_ids_l ) )  THEN
     459                IF ( ANY( building_id_f%var(j,i) ==  build_ids_l ) )  THEN
    457460                   CYCLE
    458461                ELSE
     
    521524
    522525       IF ( ALLOCATED(build_ids_final) )  THEN
    523           IF ( ANY( build_ids(n) .EQ. build_ids_final ) )  THEN    !FK: Warum ANY?, Warum .EQ.? --> s.o
     526          IF ( ANY( build_ids(n) == build_ids_final ) )  THEN    !FK: Warum ANY?, Warum .EQ.? --> s.o
    524527             CYCLE
    525528          ELSE
  • palm/trunk/SOURCE/init_grid.f90

    r4115 r4144  
    2525! -----------------
    2626! $Id$
     27! relational operators .EQ., .NE., etc. replaced by ==, /=, etc.
     28!
     29! 4115 2019-07-24 12:50:49Z suehring
    2730! Bugfix in setting near-surface flag 24, inidicating wall-bounded grid points
    2831!
     
    14691472                IF ( building_id_f%var(j,i) /= building_id_f%fill )  THEN
    14701473                   IF ( num_buildings_l(myid) > 0 )  THEN
    1471                       IF ( ANY( building_id_f%var(j,i) .EQ.  build_ids_l ) )   &
     1474                      IF ( ANY( building_id_f%var(j,i) ==  build_ids_l ) )   &
    14721475                      THEN
    14731476                         CYCLE
     
    15431546
    15441547             IF ( ALLOCATED(build_ids_final) )  THEN
    1545                 IF ( ANY( build_ids(nr) .EQ. build_ids_final ) )  THEN
     1548                IF ( ANY( build_ids(nr) == build_ids_final ) )  THEN
    15461549                   CYCLE
    15471550                ELSE
     
    15741577             oro_max_l(nr) = MAXVAL(                                              &
    15751578                              MERGE( terrain_height_f%var, 0.0_wp,                &
    1576                                      building_id_f%var(nys:nyn,nxl:nxr) .EQ.      &
     1579                                     building_id_f%var(nys:nyn,nxl:nxr) ==      &
    15771580                                     build_ids_final(nr) ) )
    15781581          ENDDO
  • palm/trunk/SOURCE/lagrangian_particle_model_mod.f90

    r4143 r4144  
    2525! -----------------
    2626! $Id$
     27! relational operators .EQ., .NE., etc. replaced by ==, /=, etc.
     28!
     29! 4143 2019-08-05 15:14:53Z schwenkel
    2730! Rename variable and change select case to if statement
    2831!
     
    13871390!
    13881391!--                            In case of stretching the actual k index is found iteratively
    1389                                IF ( dz_stretch_level .NE. -9999999.9_wp  .OR.           &
    1390                                     dz_stretch_level_start(1) .NE. -9999999.9_wp )  THEN
     1392                               IF ( dz_stretch_level /= -9999999.9_wp  .OR.           &
     1393                                    dz_stretch_level_start(1) /= -9999999.9_wp )  THEN
    13911394                                  kp = MINLOC( ABS( tmp_particle%z - zu ), DIM = 1 ) - 1
    13921395                               ELSE
     
    16481651!
    16491652!-- Set constants for different aerosol species
    1650     IF ( TRIM(aero_species) .EQ. 'nacl' )  THEN
     1653    IF ( TRIM(aero_species) == 'nacl' )  THEN
    16511654       molecular_weight_of_solute = 0.05844_wp
    16521655       rho_s                      = 2165.0_wp
    16531656       vanthoff                   = 2.0_wp
    1654     ELSEIF ( TRIM(aero_species) .EQ. 'c3h4o4' )  THEN
     1657    ELSEIF ( TRIM(aero_species) == 'c3h4o4' )  THEN
    16551658       molecular_weight_of_solute = 0.10406_wp
    16561659       rho_s                      = 1600.0_wp
    16571660       vanthoff                   = 1.37_wp
    1658     ELSEIF ( TRIM(aero_species) .EQ. 'nh4o3' )  THEN
     1661    ELSEIF ( TRIM(aero_species) == 'nh4o3' )  THEN
    16591662       molecular_weight_of_solute = 0.08004_wp
    16601663       rho_s                      = 1720.0_wp
     
    16681671!-- The following typical aerosol spectra are taken from Jaenicke (1993):
    16691672!-- Tropospheric aerosols. Published in Aerosol-Cloud-Climate Interactions.
    1670     IF ( TRIM(aero_type) .EQ. 'polar' )  THEN
     1673    IF ( TRIM(aero_type) == 'polar' )  THEN
    16711674       na        = (/ 2.17e1, 1.86e-1, 3.04e-4 /) * 1.0E6_wp
    16721675       rm        = (/ 0.0689, 0.375, 4.29 /) * 1.0E-6_wp
    16731676       log_sigma = (/ 0.245, 0.300, 0.291 /)
    1674     ELSEIF ( TRIM(aero_type) .EQ. 'background' )  THEN
     1677    ELSEIF ( TRIM(aero_type) == 'background' )  THEN
    16751678       na        = (/ 1.29e2, 5.97e1, 6.35e1 /) * 1.0E6_wp
    16761679       rm        = (/ 0.0036, 0.127, 0.259 /) * 1.0E-6_wp
    16771680       log_sigma = (/ 0.645, 0.253, 0.425 /)
    1678     ELSEIF ( TRIM(aero_type) .EQ. 'maritime' )  THEN
     1681    ELSEIF ( TRIM(aero_type) == 'maritime' )  THEN
    16791682       na        = (/ 1.33e2, 6.66e1, 3.06e0 /) * 1.0E6_wp
    16801683       rm        = (/ 0.0039, 0.133, 0.29 /) * 1.0E-6_wp
    16811684       log_sigma = (/ 0.657, 0.210, 0.396 /)
    1682     ELSEIF ( TRIM(aero_type) .EQ. 'continental' )  THEN
     1685    ELSEIF ( TRIM(aero_type) == 'continental' )  THEN
    16831686       na        = (/ 3.20e3, 2.90e3, 3.00e-1 /) * 1.0E6_wp
    16841687       rm        = (/ 0.01, 0.058, 0.9 /) * 1.0E-6_wp
    16851688       log_sigma = (/ 0.161, 0.217, 0.380 /)
    1686     ELSEIF ( TRIM(aero_type) .EQ. 'desert' )  THEN
     1689    ELSEIF ( TRIM(aero_type) == 'desert' )  THEN
    16871690       na        = (/ 7.26e2, 1.14e3, 1.78e-1 /) * 1.0E6_wp
    16881691       rm        = (/ 0.001, 0.0188, 10.8 /) * 1.0E-6_wp
    16891692       log_sigma = (/ 0.247, 0.770, 0.438 /)
    1690     ELSEIF ( TRIM(aero_type) .EQ. 'rural' )  THEN
     1693    ELSEIF ( TRIM(aero_type) == 'rural' )  THEN
    16911694       na        = (/ 6.65e3, 1.47e2, 1.99e3 /) * 1.0E6_wp
    16921695       rm        = (/ 0.00739, 0.0269, 0.0419 /) * 1.0E-6_wp
    16931696       log_sigma = (/ 0.225, 0.557, 0.266 /)
    1694     ELSEIF ( TRIM(aero_type) .EQ. 'urban' )  THEN
     1697    ELSEIF ( TRIM(aero_type) == 'urban' )  THEN
    16951698       na        = (/ 9.93e4, 1.11e3, 3.64e4 /) * 1.0E6_wp
    16961699       rm        = (/ 0.00651, 0.00714, 0.0248 /) * 1.0E-6_wp
    16971700       log_sigma = (/ 0.245, 0.666, 0.337 /)
    1698     ELSEIF ( TRIM(aero_type) .EQ. 'user' )  THEN
     1701    ELSEIF ( TRIM(aero_type) == 'user' )  THEN
    16991702       CONTINUE
    17001703    ELSE
     
    17391742
    17401743                IF ( particles(n)%weight_factor - FLOOR(particles(n)%weight_factor,KIND=wp) &
    1741                      .GT. random_function( iran_part ) )  THEN
     1744                     > random_function( iran_part ) )  THEN
    17421745                   particles(n)%weight_factor = FLOOR(particles(n)%weight_factor,KIND=wp) + 1.0_wp
    17431746                ELSE
     
    17461749!
    17471750!--             Unnecessary particles will be deleted
    1748                 IF ( particles(n)%weight_factor .LE. 0.0_wp )  particles(n)%particle_mask = .FALSE.
     1751                IF ( particles(n)%weight_factor <= 0.0_wp )  particles(n)%particle_mask = .FALSE.
    17491752
    17501753             ENDDO
     
    51035106   !--          Check error of the solution, and reduce dt_ros if necessary.
    51045107                error = ABS(r_err - r_ros) / r_ros
    5105                 IF ( error .GT. prec )  THEN
     5108                IF ( error > prec )  THEN
    51065109                   dt_ros = SQRT( q_decrease * prec / error ) * dt_ros
    51075110                   r_ros  = r_ros_ini
     
    54045407!--          For collisions, the weighting factor of at least one super-droplet
    54055408!--          needs to be larger or equal to one.
    5406              IF ( MIN( weight(n), weight(m) ) .LT. 1.0_wp )  CYCLE
     5409             IF ( MIN( weight(n), weight(m) ) < 1.0_wp )  CYCLE
    54075410!
    54085411!--          Get mass of individual droplets (aerosols)
     
    54295432!--          (Accordingly, p_crit will be 0.0, 1.0, 2.0, ...)
    54305433             IF ( collection_probability - FLOOR(collection_probability)    &
    5431                   .GT. random_function( iran_part ) )  THEN
     5434                  > random_function( iran_part ) )  THEN
    54325435                collection_probability = FLOOR(collection_probability) + 1.0_wp
    54335436             ELSE
     
    54355438             ENDIF
    54365439
    5437              IF ( collection_probability .GT. 0.0_wp )  THEN
     5440             IF ( collection_probability > 0.0_wp )  THEN
    54385441!
    54395442!--             Super-droplet n collects droplets of super-droplet m
    5440                 IF ( weight(n) .LT. weight(m) )  THEN
     5443                IF ( weight(n) < weight(m) )  THEN
    54415444
    54425445                   mass(n)   = mass(n)   + weight(n) * xm * collection_probability
     
    54485451                   ENDIF
    54495452
    5450                 ELSEIF ( weight(m) .LT. weight(n) )  THEN
     5453                ELSEIF ( weight(m) < weight(n) )  THEN
    54515454
    54525455                   mass(m)   = mass(m)   + weight(m) * xn * collection_probability
     
    76157618!
    76167619!--    In case of stretching the actual k index must be found
    7617        IF ( dz_stretch_level .NE. -9999999.9_wp  .OR.         &
    7618             dz_stretch_level_start(1) .NE. -9999999.9_wp )  THEN
     7620       IF ( dz_stretch_level /= -9999999.9_wp  .OR.         &
     7621            dz_stretch_level_start(1) /= -9999999.9_wp )  THEN
    76197622          kp = MINLOC( ABS( particle_array(n)%z - zu ), DIM = 1 ) - 1
    76207623       ELSE
  • palm/trunk/SOURCE/random_function_mod.f90

    r3802 r4144  
    2525! -----------------
    2626! $Id$
     27! relational operators .EQ., .NE., etc. replaced by ==, /=, etc.
     28!
     29! 3802 2019-03-17 13:33:42Z raasch
    2730! type conversion added to avoid compiler warning about constant integer
    2831! division truncation
     
    7376! ------------
    7477!> Random number generator, produces numbers equally distributed in interval [0,1]
    75 !> This routine is taken from the "numerical recipies"
     78!> This routine is taken from the "numerical recipes"
    7679!------------------------------------------------------------------------------!
    7780 MODULE random_function_mod
     
    137140                   ntab=32, ndiv=1+INT(REAL(im-1)/ntab), eps=1.2e-7_wp, rnmx=1.0_wp-eps )
    138141
    139        IF ( idum .le. 0  .or.  random_iy .eq. 0 )  THEN
     142       IF ( idum <= 0  .OR.  random_iy == 0 )  THEN
    140143          idum = max (-idum,1)
    141144          DO  j = ntab+8,1,-1
    142145             k    = idum / iq
    143146             idum = ia * ( idum - k * iq ) - ir * k
    144              IF ( idum .lt. 0 )  idum = idum + im
    145              IF ( j .le. ntab )  random_iv(j) = idum
     147             IF ( idum < 0 )  idum = idum + im
     148             IF ( j <= ntab )  random_iv(j) = idum
    146149          ENDDO
    147150          random_iy = random_iv(1)
     
    150153       k    = idum / iq
    151154       idum = ia * ( idum - k * iq ) - ir * k
    152        IF ( idum .lt. 0 )  idum = idum + im
     155       IF ( idum < 0 )  idum = idum + im
    153156       j            = 1 + random_iy / ndiv
    154157       random_iy    = random_iv(j)
    155158       random_iv(j) = idum
    156        random_function  = min ( am * random_iy , rnmx )
     159       random_function  = MIN( am * random_iy , rnmx )
    157160
    158161    END FUNCTION random_function
  • palm/trunk/SOURCE/synthetic_turbulence_generator_mod.f90

    r4071 r4144  
    2525! -----------------
    2626! $Id$
     27! relational operators .EQ., .NE., etc. replaced by ==, /=, etc.
     28!
     29! 4071 2019-07-03 20:02:00Z suehring
    2730! Bugfix, initialize mean_inflow_profiles in case turbulence and inflow
    2831! information is not read from file.
     
    996999          DO  j = nysg, nyng
    9971000             DO  k = nzb, nzt+1
    998                 IF  ( a11(k) .NE. 0._wp ) THEN
     1001                IF  ( a11(k) /= 0.0_wp ) THEN
    9991002                   fu_yz(k,j) = ( u(k,j,i) - u_init(k) ) / a11(k)
    10001003                ELSE
    1001                    fu_yz(k,j) = 0._wp
     1004                   fu_yz(k,j) = 0.0_wp
    10021005                ENDIF
    10031006
    1004                 IF  ( a22(k) .NE. 0._wp ) THEN
     1007                IF  ( a22(k) /= 0.0_wp ) THEN
    10051008                   fv_yz(k,j) = ( v(k,j,i) -                                  &
    10061009                                  a21(k) * fu_yz(k,j) - v_init(k) ) / a22(k)
    10071010                ELSE
    1008                    fv_yz(k,j) = 0._wp
     1011                   fv_yz(k,j) = 0.0_wp
    10091012                ENDIF
    10101013
    1011                 IF  ( a33(k) .NE. 0._wp ) THEN
     1014                IF  ( a33(k) /= 0.0_wp ) THEN
    10121015                   fw_yz(k,j) = ( w(k,j,i) -                                   &
    10131016                                  a31(k) * fu_yz(k,j) - a32(k) *               &
     
    10291032             DO  k = nzb, nzt+1
    10301033
    1031                 IF  ( a11(k) .NE. 0._wp ) THEN
     1034                IF  ( a11(k) /= 0.0_wp ) THEN
    10321035                   fu_xz(k,i) = ( u(k,j,i) - u_init(k) ) / a11(k)
    10331036                ELSE
    1034                    fu_xz(k,i) = 0._wp
     1037                   fu_xz(k,i) = 0.0_wp
    10351038                ENDIF
    10361039
    1037                 IF  ( a22(k) .NE. 0._wp ) THEN
     1040                IF  ( a22(k) /= 0.0_wp ) THEN
    10381041                   fv_xz(k,i) = ( v(k,j,i) -                                   &
    10391042                                  a21(k) * fu_xz(k,i) - v_init(k) ) / a22(k)
    10401043                ELSE
    1041                    fv_xz(k,i) = 0._wp
     1044                   fv_xz(k,i) = 0.0_wp
    10421045                ENDIF
    10431046
    1044                 IF  ( a33(k) .NE. 0._wp ) THEN
     1047                IF  ( a33(k) /= 0.0_wp ) THEN
    10451048                   fw_xz(k,i) = ( w(k,j,i) -                                   &
    10461049                                  a31(k) * fu_xz(k,i) -                        &
  • palm/trunk/SOURCE/time_integration.f90

    r4126 r4144  
    2525! -----------------
    2626! $Id$
     27! relational operators .EQ., .NE., etc. replaced by ==, /=, etc.
     28!
     29! 4126 2019-07-30 11:09:11Z gronemeier
    2730! renamed routine to calculate uv exposure
    2831!
     
    15651568!
    15661569!--       Call emission routine only once an hour
    1567           IF (hour_of_year  .GT.  hour_call_emis )  THEN
     1570          IF ( hour_of_year  >  hour_call_emis )  THEN
    15681571             CALL chem_emissions_setup( chem_emis_att, chem_emis, n_matched_vars )
    15691572             hour_call_emis = hour_of_year
  • palm/trunk/SOURCE/wind_turbine_model_mod.f90

    r4056 r4144  
    2626! -----------------
    2727! $Id$
     28! relational operators .EQ., .NE., etc. replaced by ==, /=, etc.
     29!
     30! 4056 2019-06-27 13:53:16Z Giersch
    2831! CASE DEFAULT action in wtm_actions needs to be CONTINUE. Otherwise an abort 
    2932! will happen for location values that are not implemented as CASE statements
     
    15221525!             lct(1) = lct(1)
    15231526
    1524           IF ( ( trad1(lct(1)) - cur_r ) .GT. 0.0 )  THEN
     1527          IF ( ( trad1(lct(1)) - cur_r ) > 0.0 )  THEN
    15251528             lct(1) = lct(1) - 1
    15261529          ENDIF
     
    15341537          t2 = ttoint2(trow)
    15351538
    1536           IF ( t1 .EQ. t2 ) THEN  ! if both are the same, the weights are NaN
    1537              weight_a = 0.5_wp    ! then do interpolate in between same twice
    1538              weight_b = 0.5_wp    ! using 0.5 as weight
     1539          IF ( t1 == t2 ) THEN  ! if both are the same, the weights are NaN
     1540             weight_a = 0.5_wp     ! then do interpolate in between same twice
     1541             weight_b = 0.5_wp     ! using 0.5 as weight
    15391542          ENDIF
    15401543
Note: See TracChangeset for help on using the changeset viewer.