Changeset 1240


Ignore:
Timestamp:
Oct 29, 2013 1:21:31 PM (10 years ago)
Author:
heinze
Message:

Undoing commit 1239

Location:
palm/trunk/SOURCE
Files:
15 edited

Legend:

Unmodified
Added
Removed
  • palm/trunk/SOURCE/Makefile

    r1239 r1240  
    2020# Current revisions:
    2121# ------------------
    22 # +nudging, ls_forcing
     22#
    2323#
    2424# Former revisions:
     
    158158        lpm_set_attributes.f90 lpm_sort_arrays.f90 \
    159159        lpm_write_exchange_statistics.f90 lpm_write_restart_file.f90 \
    160         ls_forcing.f90 \
    161         message.f90 microphysics.f90 modules.f90 netcdf.f90 nudging.f90 \
    162         package_parin.f90 palm.f90 parin.f90 plant_canopy_model.f90 poisfft.f90 \
     160        message.f90 microphysics.f90 modules.f90 netcdf.f90 package_parin.f90 \
     161        palm.f90 parin.f90 plant_canopy_model.f90 poisfft.f90 \
    163162        poismg.f90 prandtl_fluxes.f90 pres.f90 print_1d.f90 \
    164163        production_e.f90 prognostic_equations.f90 random_function.f90 \
     
    304303lpm_write_exchange_statistics.o: modules.o
    305304lpm_write_restart_file.o: modules.o
    306 ls_forcing.o: modules.o
    307305message.o: modules.o
    308306microphysics.o: modules.o
    309307modules.o: modules.f90
    310308netcdf.o: modules.o
    311 nudging.o: modules.o
    312309package_parin.o: modules.o
    313 palm.o: modules.o nudging.o ls_forcing.o
     310palm.o: modules.o
    314311parin.o: modules.o
    315312plant_canopy_model.o: modules.o
    316313poisfft.o: modules.o fft_xy.o tridia_solver.o
    317314poismg.o: modules.o
    318 prandtl_fluxes.o: modules.o ls_forcing.o
     315prandtl_fluxes.o: modules.o
    319316pres.o: modules.o poisfft.o
    320317print_1d.o: modules.o
     
    325322        diffusion_e.o diffusion_s.o diffusion_u.o diffusion_v.o diffusion_w.o \
    326323        eqn_state_seawater.o impact_of_latent_heat.o microphysics.o \
    327         nudging.o plant_canopy_model.o production_e.o subsidence.o user_actions.o
     324        plant_canopy_model.o production_e.o subsidence.o user_actions.o
    328325random_gauss.o: random_function.o
    329326read_3d_binary.o: modules.o random_function.o
     
    339336temperton_fft.o: modules.o
    340337time_integration.o: modules.o advec_ws.o buoyancy.o interaction_droplets_ptq.o \
    341         ls_forcing.o production_e.o prognostic_equations.o user_actions.o
     338        production_e.o prognostic_equations.o user_actions.o
    342339timestep.o: modules.o
    343340timestep_scheme_steering.o: modules.o
  • palm/trunk/SOURCE/boundary_conds.f90

    r1239 r1240  
    2020! Current revisions:
    2121! -----------------
    22 ! Adjust ug and vg at each timestep in case of large_scale_forcing
     22!
    2323
    2424! Former revisions:
     
    147147        u_p(nzt+1,:,:) = u_init(nzt+1)
    148148        v_p(nzt+1,:,:) = v_init(nzt+1)
    149         IF ( large_scale_forcing) THEN
    150            u_p(nzt+1,:,:) = ug(nzt+1)
    151            v_p(nzt+1,:,:) = vg(nzt+1)
    152         END IF
    153149       !$acc end kernels
    154150    ELSE
  • palm/trunk/SOURCE/buoyancy.f90

    r1239 r1240  
    2020! Currrent revisions:
    2121! ------------------
    22 ! Generalize calc_mean_profile for wider use: use additional steering
    23 ! character loc
    2422!
    2523!
     
    346344
    347345
    348     SUBROUTINE calc_mean_profile( var, pr, loc )
     346    SUBROUTINE calc_mean_profile( var, pr )
    349347
    350348!------------------------------------------------------------------------------!
     
    365363
    366364       INTEGER ::  i, j, k, omp_get_thread_num, pr, tn
    367        CHARACTER (LEN=*) ::  loc
    368365#if defined( __nopointer )
    369366       REAL, DIMENSION(:,:,:) ::  var
     
    417414       ENDIF
    418415
    419        SELECT CASE ( loc )
    420 
    421           CASE ( 'time_int' )
    422 
    423              ref_state(:)  = hom(:,1,pr,0)   ! this is used in the buoyancy term
    424 
    425 
    426           CASE ( 'nudging' )
    427              !nothing to be done
    428 
    429 
    430           CASE DEFAULT
    431              message_string = 'unknown location "' // loc // '"'
    432              CALL message( 'calc_mean_profile', 'PA0379', 1, 2, 0, 6, 0 )
    433 
    434        END SELECT
    435 
    436 
     416       ref_state(:)  = hom(:,1,pr,0)   ! this is used in the buoyancy term
    437417
    438418    END SUBROUTINE calc_mean_profile
  • palm/trunk/SOURCE/check_parameters.f90

    r1239 r1240  
    2020! Current revisions:
    2121! -----------------
    22 ! profiles of ug and vg added
    23 ! checks for nudging and large scale forcing from external file
     22!
    2423!
    2524! Former revisions:
     
    312311    USE statistics
    313312    USE subsidence_mod
    314     USE statistics
    315313    USE transpose_indices
    316314
     
    16081606    ENDIF
    16091607
    1610     IF (myid == 0 )THEN
    1611       PRINT*, "vorher surface_heatflux: ", surface_heatflux
    1612     END IF
    1613 
    1614     IF ( surface_heatflux == 9999999.9  .AND.  .NOT. large_scale_forcing )  THEN
    1615         constant_heatflux     = .FALSE.
    1616     ELSE
    1617         constant_heatflux     = .TRUE.
    1618         IF ( TRIM( initializing_actions ) /= 'read_restart_data' ) THEN
    1619            surface_heatflux      = shf_surf(1)
    1620         ENDIF
    1621     ENDIF
    1622 
    1623     IF (myid == 0 )THEN
    1624       PRINT*, "nachher surface_heatflux: ", surface_heatflux
    1625     END IF
    1626 
     1608    IF ( surface_heatflux == 9999999.9 )  constant_heatflux     = .FALSE.
    16271609    IF ( top_heatflux     == 9999999.9 )  constant_top_heatflux = .FALSE.
    16281610
     
    17441726       ENDIF
    17451727
    1746        IF ( surface_waterflux == 9999999.9  .AND.  &
    1747                              .NOT. large_scale_forcing )  THEN
    1748            constant_waterflux     = .FALSE.
    1749        ELSE
    1750            constant_waterflux     = .TRUE.
    1751            IF ( TRIM( initializing_actions ) /= 'read_restart_data' ) THEN
    1752               surface_waterflux      = qsws_surf(1)
    1753            ENDIF
    1754        ENDIF
     1728       IF ( surface_waterflux == 9999999.9 )  constant_waterflux = .FALSE.
    17551729
    17561730!
     
    26922666             ENDIF
    26932667
    2694           CASE ( 'ug' )
    2695              dopr_index(i) = 78
    2696              dopr_unit(i)  = 'm/s'
    2697              hom(:,2,78,:) = SPREAD( zu, 2, statistic_regions+1 )
    2698 
    2699           CASE ( 'vg' )
    2700              dopr_index(i) = 79
    2701              dopr_unit(i)  = 'm/s'
    2702              hom(:,2,79,:) = SPREAD( zu, 2, statistic_regions+1 )
    2703 
    27042668          CASE DEFAULT
    27052669
     
    36333597
    36343598!
    3635 !-- Check nudging and large scale forcing from external file
    3636     IF ( nudging .AND. ( .NOT. large_scale_forcing ) )  THEN
    3637        message_string = 'Nudging requires large_scale_forcing = .T.. &'// &
    3638                         'Surface fluxes and geostrophic wind should be &'// &
    3639                         'prescribed in file LSF_DATA'
    3640        CALL message( 'check_parameters', 'PA0374', 1, 2, 0, 6, 0 )
    3641     ENDIF
    3642 
    3643     IF ( large_scale_forcing .AND. ( bc_lr /= 'cyclic'  .OR. &
    3644                                     bc_ns /= 'cyclic' ) )  THEN
    3645        message_string = 'Non-cyclic lateral boundaries do not allow for &' // &
    3646                         'the usage of large scale forcing from external file.'
    3647        CALL message( 'check_parameters', 'PA0375', 1, 2, 0, 6, 0 )
    3648      ENDIF
    3649 
    3650     IF ( large_scale_forcing .AND. ( .NOT. humidity ) )  THEN
    3651        message_string = 'The usage of large scale forcing from external &'//&
    3652                         'file LSF_DATA requires humidity = .T..'
    3653        CALL message( 'check_parameters', 'PA0376', 1, 2, 0, 6, 0 )
    3654      ENDIF
    3655 
    3656     IF ( large_scale_forcing .AND. topography /= 'flat' )  THEN
    3657        message_string = 'The usage of large scale forcing from external &'//&
    3658                         'file LSF_DATA is not implemented for non-flat topography'
    3659        CALL message( 'check_parameters', 'PA0377', 1, 2, 0, 6, 0 )
    3660     ENDIF
    3661 
    3662     IF ( large_scale_forcing .AND.  ocean  )  THEN
    3663        message_string = 'The usage of large scale forcing from external &'//&
    3664                         'file LSF_DATA is not implemented for ocean runs'
    3665        CALL message( 'check_parameters', 'PA0378', 1, 2, 0, 6, 0 )
    3666     ENDIF
    3667 !
    36683599!-- Check &userpar parameters
    36693600    CALL user_check_parameters
  • palm/trunk/SOURCE/flow_statistics.f90

    r1239 r1240  
    2121! Current revisions:
    2222! -----------------
    23 ! Output of ug and vg
     23!
    2424!
    2525! Former revisions:
     
    563563          ENDDO
    564564       ENDIF
    565 
    566565!
    567566!--    Horizontally averaged profiles of the vertical fluxes
     
    887886
    888887       ENDIF
     888
    889889
    890890!
     
    11561156       hom(:,1,76,sr) = sums(:,76)     ! prr (precipitation rate)
    11571157                                       ! 77 is initial density profile
    1158        hom(:,1,78,sr) = ug             ! ug
    1159        hom(:,1,79,sr) = vg             ! vg
    11601158
    11611159       hom(:,1,pr_palm-1,sr) = sums(:,pr_palm-1)
     
    27762774       hom(:,1,76,sr) = sums(:,76)     ! prr (precipitation rate)
    27772775                                       ! 77 is initial density profile
    2778        hom(:,1,78,sr) = ug             ! ug
    2779        hom(:,1,79,sr) = vg             ! vg
    27802776
    27812777       hom(:,1,pr_palm-1,sr) = sums(:,pr_palm-1)
  • palm/trunk/SOURCE/header.f90

    r1239 r1240  
    2020! Current revisions:
    2121! -----------------
    22 ! output for nudging + large scale forcing from external file
     22!
    2323!
    2424! Former revisions:
     
    428428        WRITE ( io, 154 )
    429429    ENDIF
    430     IF ( nudging )  THEN
    431         WRITE ( io, 155 )
    432         WRITE ( io, 156 )
    433     ENDIF
    434     IF ( large_scale_forcing )  THEN
    435         WRITE ( io, 157 )
    436         WRITE ( io, 158 )
    437     ENDIF
    438430    WRITE ( io, 99 )
    439431
     
    714706       WRITE ( io, 303 )
    715707       IF ( constant_heatflux )  THEN
    716           IF ( large_scale_forcing .AND. lsf_surf ) THEN
    717              WRITE ( io, 306 )  shf(0,0)
    718           ELSE
    719              WRITE ( io, 306 )  surface_heatflux
    720           ENDIF
     708          WRITE ( io, 306 )  surface_heatflux
    721709          IF ( random_heatflux )  WRITE ( io, 307 )
    722710       ENDIF
    723711       IF ( humidity  .AND.  constant_waterflux )  THEN
    724           IF ( large_scale_forcing .AND. lsf_surf ) THEN
    725              WRITE ( io, 311 ) qsws(0,0)
    726           ELSE
    727              WRITE ( io, 311 ) surface_waterflux
    728           ENDIF
     712          WRITE ( io, 311 ) surface_waterflux
    729713       ENDIF
    730714       IF ( passive_scalar  .AND.  constant_waterflux )  THEN
     
    13041288    ENDDO
    13051289
    1306     IF ( .NOT. large_scale_forcing ) THEN
    1307        WRITE ( io, 423 )  TRIM( coordinates ), TRIM( ugcomponent ), &
    1308                           TRIM( gradients ), TRIM( slices )
    1309     ELSE
    1310        WRITE ( io, 429 )
    1311     ENDIF
     1290    WRITE ( io, 423 )  TRIM( coordinates ), TRIM( ugcomponent ), &
     1291                       TRIM( gradients ), TRIM( slices )
    13121292
    13131293!-- Profile of the geostrophic wind (component vg)
     
    13401320    ENDDO
    13411321
    1342     IF ( .NOT. large_scale_forcing ) THEN
    1343        WRITE ( io, 424 )  TRIM( coordinates ), TRIM( vgcomponent ), &
    1344                           TRIM( gradients ), TRIM( slices )
    1345     ENDIF
     1322    WRITE ( io, 424 )  TRIM( coordinates ), TRIM( vgcomponent ), &
     1323                       TRIM( gradients ), TRIM( slices )
    13461324
    13471325!
     
    13791357    ENDDO
    13801358
    1381     IF ( .NOT. nudging ) THEN
    1382        WRITE ( io, 420 )  TRIM( coordinates ), TRIM( temperatures ), &
    1383                           TRIM( gradients ), TRIM( slices )
    1384     ELSE
    1385        WRITE ( io, 428 )
    1386     ENDIF
     1359    WRITE ( io, 420 )  TRIM( coordinates ), TRIM( temperatures ), &
     1360                       TRIM( gradients ), TRIM( slices )
    13871361
    13881362!
     
    14181392
    14191393       IF ( humidity )  THEN
    1420           IF ( .NOT. nudging ) THEN
    1421              WRITE ( io, 421 )  TRIM( coordinates ), TRIM( temperatures ), &
    1422                                 TRIM( gradients ), TRIM( slices )
    1423           ENDIF
     1394          WRITE ( io, 421 )  TRIM( coordinates ), TRIM( temperatures ), &
     1395                             TRIM( gradients ), TRIM( slices )
    14241396       ELSE
    14251397          WRITE ( io, 422 )  TRIM( coordinates ), TRIM( temperatures ), &
     
    17331705                  'prognostic equation for')
    17341706154 FORMAT ('     the potential temperature')
    1735 155 FORMAT (' --> Nudging is used - initial profiles for u, v, pt and q ',&
    1736                   'correspond to the')
    1737 156 FORMAT ('     first profiles in NUDGING_DATA')
    1738 157 FORMAT (' --> Large scale forcing from external file (LSF_DATA) is used: ')
    1739 158 FORMAT ('     prescribed surfaces fluxes and geostrophic wind components')
    17401707200 FORMAT (//' Run time and time step information:'/ &
    17411708             ' ----------------------------------'/)
     
    19901957427 FORMAT (/'    Initial wind profiles (u,v) are interpolated from given'// &
    19911958                  ' profiles')
    1992 428 FORMAT (/'    Initial profiles (u, v, pt, q) are taken from file '/ &
    1993              '    NUDGING_DATA')
    1994 429 FORMAT (/'    Geostrophic wind profiles (ug, vg) are are taken from file '/ &
    1995              '    LSF_DATA_DATA')
    19961959430 FORMAT (//' Cloud physics quantities / methods:'/ &
    19971960              ' ----------------------------------'/)
  • palm/trunk/SOURCE/init_3d_model.f90

    r1239 r1240  
    2323! Current revisions:
    2424! ------------------
    25 ! Overwrite initial profiles in case of nudging
    26 ! Inititialize shf and qsws in case of large_scale_forcing
     25!
    2726!
    2827! Former revisions:
     
    261260    USE indices
    262261    USE interfaces
    263     USE ls_forcing_mod
    264262    USE model_1d
    265263    USE netcdf_control
     
    782780       ELSEIF ( INDEX(initializing_actions, 'set_constant_profiles') /= 0 ) &
    783781       THEN
    784 
    785 !
    786 !--       Overwrite initial profiles in case of nudging
    787           IF ( nudging ) THEN
    788              pt_init = ptnudge(:,1)
    789              u_init  = unudge(:,1)
    790              v_init  = vnudge(:,1)
    791              IF ( humidity  .OR.  passive_scalar )  THEN
    792                 q_init = qnudge(:,1)
    793              ENDIF
    794 
    795              WRITE( message_string, * ) 'Initial profiles of u, v and ', &
    796                  'scalars from NUDGING_DATA are used.'
    797              CALL message( 'init_3d_model', 'PA0370', 0, 0, 0, 6, 0 )
    798           ENDIF
    799 
    800782!
    801783!--       Use constructed initial profiles (velocity constant with height,
     
    891873          IF ( sloping_surface )  CALL init_slope
    892874
    893           IF(myid==0) THEN
    894             PRINT*,"initial profiles from init_3d_model"
    895             DO k=nzb, nzt+1
    896                 PRINT*, k, u(k,0,0), v(k,0,0), pt(k,0,0), q(k,0,0)
    897             ENDDO
    898           ENDIF
    899 
    900875       ELSEIF ( INDEX(initializing_actions, 'by_user') /= 0 ) &
    901876       THEN
     
    973948             ELSE
    974949                shf = surface_heatflux
    975 !
    976 !--             Initialize shf with data from external file LSF_DATA
    977                 IF ( large_scale_forcing .AND. lsf_surf ) THEN
    978                    CALL ls_forcing_surf ( simulated_time )
    979                 ENDIF
    980 
    981950!
    982951!--             Over topography surface_heatflux is replaced by wall_heatflux(0)
  • palm/trunk/SOURCE/microphysics.f90

    r1239 r1240  
    2020! Current revisions:
    2121! ------------------
    22 ! hyp and rho have to be calculated at each time step if data from external
    23 ! file LSF_DATA are used
     22!
    2423!
    2524! Former revisions:
     
    104103
    105104       USE arrays_3d
    106        USE cloud_parameters
    107        USE control_parameters
    108        USE grid_variables
     105       USE control_parameters
    109106       USE indices
    110107       USE statistics
     
    299296       USE cloud_parameters
    300297       USE control_parameters
    301        USE grid_variables
    302        USE indices
    303298       USE statistics
    304299
    305300       IMPLICIT NONE
    306301
    307        INTEGER ::  i, j, k
    308        REAL    ::  t_surface
    309 
    310        IF ( large_scale_forcing .AND. lsf_surf ) THEN
    311 !
    312 !--       Calculate:
    313 !--       pt / t : ratio of potential and actual temperature (pt_d_t)
    314 !--       t / pt : ratio of actual and potential temperature (t_d_pt)
    315 !--       p_0(z) : vertical profile of the hydrostatic pressure (hyp)
    316           t_surface = pt_surface * ( surface_pressure / 1000.0 )**0.286
    317           DO  k = nzb, nzt+1
    318              hyp(k)    = surface_pressure * 100.0 * &
    319                          ( (t_surface - g/cp * zu(k)) / t_surface )**(1.0/0.286)
    320              pt_d_t(k) = ( 100000.0 / hyp(k) )**0.286
    321              t_d_pt(k) = 1.0 / pt_d_t(k)
    322              hyrho(k)  = hyp(k) / ( r_d * t_d_pt(k) * pt_init(k) )       
    323           ENDDO
    324 !
    325 !--       Compute reference density
    326           rho_surface = surface_pressure * 100.0 / ( r_d * t_surface )
    327        ENDIF
    328 
     302       INTEGER ::  i, j
    329303
    330304       dt_micro = dt_3d * weight_pres(intermediate_timestep_count)
  • palm/trunk/SOURCE/modules.f90

    r1239 r1240  
    2020! Current revisions:
    2121! ------------------
    22 ! Usage of nudging enabled
    23 ! +nudging, ntnudge, ptnudge, qnudge, tnudge, unudge, vnudge, wnudge
    24 ! increase pr_palm from 80 to 90 to allow for more standard profiles
    25 !
    26 ! Enable prescribed time depenend surface fluxes and geostrophic wind read in
    27 ! from external file LSF_DATA
    28 ! +large_scale_forcing, lsf_surf, lsf_vert, nlsf, time_surf, shf_surf, qsws_surf,
    29 !  pt_surf, q_surf, p_surf, time_vert, ug_vert, vg_vert, wsubs_vert
     22!
    3023!
    3124! Former revisions:
     
    441434          c_u_m, c_u_m_l, c_v_m, c_v_m_l, c_w_m, c_w_m_l, ddzu, ddzu_pres,     &
    442435          dd2zu, dzu, ddzw, dzw, hyp, inflow_damping_factor, lad, l_grid,      &
    443           nc_1d, nr_1d, ptdf_x, ptdf_y, p_surf, pt_surf, pt_1d, pt_init,       &
    444           qsws_surf, q_1d, q_init, q_surf, qc_1d, qr_1d, rdf, rdf_sc,          &
    445           ref_state, sa_init, shf_surf, timenudge, time_surf, time_vert, ug,   &
    446           u_init, u_nzb_p1_for_vfc, vg, v_init, v_nzb_p1_for_vfc, w_subs, zu, zw
     436          nc_1d, nr_1d, ptdf_x, ptdf_y, pt_1d, pt_init, q_1d, q_init, qc_1d,   &
     437          qr_1d, rdf, rdf_sc, ref_state, sa_init, ug, u_init,                  &
     438          u_nzb_p1_for_vfc, vg, v_init, v_nzb_p1_for_vfc, w_subs, zu, zw
    447439
    448440    REAL, DIMENSION(:,:), ALLOCATABLE ::                                       &
     
    451443          flux_s_e, flux_s_nr, flux_s_pt, flux_s_q, flux_s_qr, flux_s_sa,      &
    452444          flux_s_u, flux_s_v, flux_s_w, f1_mg, f2_mg, f3_mg,                   &
    453           mean_inflow_profiles, nrs, nrsws, nrswst, ptnudge, pt_slope_ref,     &
    454           qnudge, qs, qsws, qswst, qswst_remote, qrs, qrsws, qrswst, rif,      &
    455           saswsb, saswst, shf, tnudge, total_2d_a, total_2d_o, ts, tswst,      &
    456           ug_vert, unudge, us, usws, uswst, vnudge, vg_vert, vsws, vswst,      &
    457           wnudge, wsubs_vert, z0, z0h
     445          mean_inflow_profiles, nrs, nrsws, nrswst, pt_slope_ref, qs, qsws,    &
     446          qswst, qswst_remote, qrs, qrsws, qrswst, rif, saswsb, saswst, shf,   &
     447          total_2d_a, total_2d_o, ts, tswst, us, usws, uswst, vsws, vswst, z0, &
     448          z0h
    458449
    459450    REAL, DIMENSION(:,:,:), ALLOCATABLE ::                                     &
     
    487478    REAL, DIMENSION(:,:,:), ALLOCATABLE :: var_x, var_y, var_z, gamma_x,       &
    488479                                           gamma_y, gamma_z
    489 
    490480
    491481    SAVE
     
    725715                maximum_parallel_io_streams = -1, max_pr_user = 0, &
    726716                mgcycles = 0, mg_cycles = -1, mg_switch_to_pe0_level = 0, mid, &
    727                 nlsf = 1000, ntnudge = 100, netcdf_data_format = 2, ngsrb = 2, &
    728                 nr_timesteps_this_run = 0, &
     717                netcdf_data_format = 2, ngsrb = 2, nr_timesteps_this_run = 0, &
    729718                nsor = 20, nsor_ini = 100, n_sor, normalizing_region = 0, &
    730719                nz_do3d = -9999, pch_index = 0, prt_time_count = 0, &
     
    783772                inflow_l = .FALSE., inflow_n = .FALSE., &
    784773                inflow_r = .FALSE., inflow_s = .FALSE., &
    785                 iso2d_output = .FALSE., large_scale_forcing = .FALSE., &
    786                 large_scale_subsidence = .FALSE., lsf_surf = .TRUE., &
    787                 lsf_vert = .TRUE., lptnudge = .FALSE., lqnudge = .FALSE., &
    788                 lunudge = .FALSE., lvnudge = .FALSE., lwnudge = .FALSE., &
     774                iso2d_output = .FALSE., large_scale_subsidence = .FALSE., &
    789775                masking_method = .FALSE., mg_switch_to_pe0 = .FALSE., &
    790                 netcdf_output = .FALSE., neutral = .FALSE., nudging = .FALSE., &
    791                 ocean = .FALSE., on_device = .FALSE., &
     776                netcdf_output = .FALSE., neutral = .FALSE., ocean = .FALSE., &
     777                on_device = .FALSE., &
    792778                outflow_l = .FALSE., outflow_n = .FALSE., outflow_r = .FALSE., &
    793779                outflow_s = .FALSE., passive_scalar = .FALSE., &
     
    16751661
    16761662    CHARACTER (LEN=40) ::  region(0:9)
    1677     INTEGER ::  pr_palm = 90, statistic_regions = 0
     1663    INTEGER ::  pr_palm = 80, statistic_regions = 0
    16781664    INTEGER ::  u_max_ijk(3), v_max_ijk(3), w_max_ijk(3)
    16791665    LOGICAL ::  flow_statistics_called = .FALSE.
  • palm/trunk/SOURCE/palm.f90

    r1239 r1240  
    2020! Current revisions:
    2121! -----------------
    22 ! initialization of nudging and large scale forcing from external file
     22!
    2323!
    2424! Former revisions:
     
    110110    USE indices
    111111    USE interfaces
    112     USE ls_forcing_mod
    113112    USE model_1d
    114     USE nudge_mod
    115113    USE particle_attributes
    116114    USE pegrid
     
    219217
    220218!
    221 !-- Initialize Nudging if required
    222     IF ( nudging )  THEN
    223        CALL init_nudge
    224     ENDIF
    225 
    226 !
    227 !-- Initialize reading of large scale forcing from external file - if required
    228     IF ( large_scale_forcing )  THEN
    229        CALL init_ls_forcing
    230     ENDIF
    231 
    232 !
    233219!-- Check control parameters and deduce further quantities
    234220    CALL check_parameters
     221
    235222
    236223!
  • palm/trunk/SOURCE/parin.f90

    r1239 r1240  
    2020! Current revisions:
    2121! -----------------
    22 ! +nudging
    23 ! +large_scale_forcing
     22!
    2423!
    2524! Former revisions:
     
    240239             initializing_actions, km_constant, lad_surface, &
    241240             lad_vertical_gradient, lad_vertical_gradient_level, &
    242              large_scale_forcing, &
    243241             leaf_surface_concentration, limiter_sedimentation, &
    244242             loop_optimization, masking_method, mg_cycles, &
    245243             mg_switch_to_pe0_level, mixing_length_1d, momentum_advec, &
    246244             nc_const, netcdf_precision, neutral, ngsrb, &
    247              nsor, nsor_ini, nudging, nx, ny, nz, ocean, omega, omega_sor, &
     245             nsor, nsor_ini, nx, ny, nz, ocean, omega, omega_sor, &
    248246             passive_scalar, pch_index, phi, plant_canopy, prandtl_layer, &
    249247             prandtl_number, precipitation, psolver, pt_damping_factor, &
  • palm/trunk/SOURCE/prognostic_equations.f90

    r1239 r1240  
    2020! Current revisions:
    2121! ------------------
    22 ! usage of nudging enabled (not for accelerator version so far)
     22!
    2323!
    2424! Former revisions:
     
    182182    USE impact_of_latent_heat_mod
    183183    USE microphysics_mod
    184     USE nudge_mod
    185184    USE plant_canopy_model_mod
    186185    USE production_e_mod
     
    286285             ENDIF
    287286
    288 !
    289 !--          Nudging
    290              IF ( nudging )  CALL nudge( i, j, simulated_time, 'u' )
    291 
    292287             CALL user_actions( i, j, 'u-tendency' )
    293288!
     
    345340             ENDIF
    346341
    347 !
    348 !--          Nudging
    349              IF ( nudging )  CALL nudge( i, j, simulated_time, 'v' )
    350 
    351342             CALL user_actions( i, j, 'v-tendency' )
    352343!
     
    480471                CALL subsidence( i, j, tend, pt, pt_init )
    481472             ENDIF
    482 
    483 !
    484 !--          Nudging
    485              IF ( nudging )  CALL nudge( i, j, simulated_time, 'pt' )
    486473
    487474             CALL user_actions( i, j, 'pt-tendency' )
     
    607594                CALL subsidence( i, j, tend, q, q_init )
    608595             ENDIF
    609 
    610 !
    611 !--          Nudging
    612              IF ( nudging )  CALL nudge( i, j, simulated_time, 'q' )
    613596
    614597             CALL user_actions( i, j, 'q-tendency' )
     
    864847    ENDIF
    865848
    866 !
    867 !-- Nudging
    868     IF ( nudging )  CALL nudge( simulated_time, 'u' )
    869 
    870849    CALL user_actions( 'u-tendency' )
    871850
     
    940919    ENDIF
    941920
    942 !
    943 !-- Nudging
    944     IF ( nudging )  CALL nudge( simulated_time, 'v' )
    945 
    946921    CALL user_actions( 'v-tendency' )
    947922
     
    11171092          CALL subsidence( tend, pt, pt_init )
    11181093       ENDIF
    1119 
    1120 !
    1121 !--    Nudging
    1122        IF ( nudging )  CALL nudge( simulated_time, 'pt' )
    11231094
    11241095       CALL user_actions( 'pt-tendency' )
     
    13071278         CALL subsidence( tend, q, q_init )
    13081279       ENDIF
    1309 
    1310 !
    1311 !--    Nudging
    1312        IF ( nudging )  CALL nudge( simulated_time, 'q' )
    13131280
    13141281       CALL user_actions( 'q-tendency' )
  • palm/trunk/SOURCE/read_var_list.f90

    r1239 r1240  
    2020! Current revisions:
    2121! ------------------
    22 ! +nudging
    23 ! +large_scale_forcing
     22!
    2423!
    2524! Former revisions:
     
    449448          CASE ( 'lad_vertical_gradient_level_in' )
    450449             READ ( 13 )  lad_vertical_gradient_level_ind
    451           CASE ( 'large_scale_forcing' )
    452              READ ( 13 )  large_scale_forcing
    453450           CASE ( 'large_scale_subsidence' )
    454451             READ ( 13 )  large_scale_subsidence
     
    486483          CASE ( 'nsor_ini' )
    487484             READ ( 13 )  nsor_ini
    488           CASE ( 'nudging' )
    489              READ ( 13 )  nudging
    490485          CASE ( 'nx' )
    491486             READ ( 13 )  nx
  • palm/trunk/SOURCE/time_integration.f90

    r1239 r1240  
    2020! Current revisions:
    2121! ------------------
    22 ! Generalize calc_mean_profile for wider use
    23 ! Determine shf and qsws in dependence on data from LSF_DATA
    24 ! Determine ug and vg in dependence on data from LSF_DATA
     22!
    2523!
    2624! Former revisions:
     
    167165    USE interaction_droplets_ptq_mod
    168166    USE interfaces
    169     USE ls_forcing_mod
    170167    USE particle_attributes
    171168    USE pegrid
     
    226223
    227224!
    228 !--    Determine ug, vg and w_subs in dependence on data from external file
    229 !--    LSF_DATA
    230        IF ( large_scale_forcing .AND. lsf_vert ) THEN
    231            CALL ls_forcing_vert ( simulated_time )
    232        ENDIF
    233 
    234 !
    235225!--    Execute the user-defined actions
    236226       CALL user_actions( 'before_timestep' )
     
    258248!--          buoyancy terms (WARNING: only the respective last call of
    259249!--          calc_mean_profile defines the reference state!)
    260              IF ( .NOT. neutral )  CALL calc_mean_profile( pt, 4, 'time_int' )
    261              IF ( ocean         )  CALL calc_mean_profile( rho, 64, 'time_int' )
    262              IF ( humidity      )  CALL calc_mean_profile( vpt, 44, 'time_int' )
     250             IF ( .NOT. neutral )  CALL calc_mean_profile( pt, 4 )
     251             IF ( ocean         )  CALL calc_mean_profile( rho, 64 )
     252             IF ( humidity      )  CALL calc_mean_profile( vpt, 44 )
    263253          ENDIF
    264254
     
    576566                CALL cpu_log( log_point(19), 'prandtl_fluxes', 'stop' )
    577567             ENDIF
    578 
    579 !
    580 !--          Determine shf and qsws in dependence on data from external file
    581 !--          LSF_DATA
    582              IF ( ( large_scale_forcing .AND. lsf_surf ) .AND. &
    583                  intermediate_timestep_count == intermediate_timestep_count_max )&
    584              THEN
    585                 CALL ls_forcing_surf ( simulated_time )
    586              ENDIF
    587 
    588568!
    589569!--          Compute the diffusion coefficients
  • palm/trunk/SOURCE/write_var_list.f90

    r1239 r1240  
    2020! Current revisions:
    2121! -----------------
    22 ! +nudging
    23 ! +large_scale_forcing
     22!
    2423!
    2524! Former revisions:
     
    366365    WRITE ( 14 )  'lad_vertical_gradient_level_in'
    367366    WRITE ( 14 )  lad_vertical_gradient_level_ind
    368     WRITE ( 14 )  'large_scale_forcing           '
    369     WRITE ( 14 )  large_scale_forcing
    370367    WRITE ( 14 )  'large_scale_subsidence        '
    371368    WRITE ( 14 )  large_scale_subsidence
     
    402399    WRITE ( 14 )  'nsor_ini                      '
    403400    WRITE ( 14 )  nsor_ini
    404     WRITE ( 14 )  'nudging                       '
    405     WRITE ( 14 )  nudging
    406401    WRITE ( 14 )  'nx                            '
    407402    WRITE ( 14 )  nx
Note: See TracChangeset for help on using the changeset viewer.