Commit 6cadd57b authored by jelt's avatar jelt
Browse files

Delete old structures

Delete old tempate in favour of Ash's structure
parent c5c53e65
MODULE tide_mod
!!======================================================================
!! *** MODULE tide_mod ***
!! Compute nodal modulations corrections and pulsations
!!======================================================================
!! History : 1.0 ! 2007 (O. Le Galloudec) Original code
!!----------------------------------------------------------------------
USE dom_oce ! ocean space and time domain
USE phycst ! physical constant
USE daymod ! calendar
IMPLICIT NONE
PRIVATE
PUBLIC tide_harmo ! called by tideini and diaharm modules
PUBLIC tide_init_Wave ! called by tideini and diaharm modules
!--- NB - extend number of constituents for tide
# if defined key_FES14_tides
INTEGER, PUBLIC, PARAMETER :: jpmax_harmo = 34 !: maximum number of harmonic
# else
INTEGER, PUBLIC, PARAMETER :: jpmax_harmo = 19 !: maximum number of harmonic
# endif
!--- END NB
TYPE, PUBLIC :: tide
CHARACTER(LEN=4) :: cname_tide
REAL(wp) :: equitide
INTEGER :: nutide
INTEGER :: nt, ns, nh, np, np1, shift
INTEGER :: nksi, nnu0, nnu1, nnu2, R
INTEGER :: nformula
END TYPE tide
TYPE(tide), PUBLIC, DIMENSION(jpmax_harmo) :: Wave !:
REAL(wp) :: sh_T, sh_s, sh_h, sh_p, sh_p1 ! astronomic angles
REAL(wp) :: sh_xi, sh_nu, sh_nuprim, sh_nusec, sh_R !
REAL(wp) :: sh_I, sh_x1ra, sh_N !
!!----------------------------------------------------------------------
!! NEMO/OPA 3.3 , LOCEAN-IPSL (2010)
!! $Id: tide_mod.F90 5215 2015-04-15 16:11:56Z nicolasmartin $
!! Software governed by the CeCILL licence (modipsl/doc/NEMO_CeCILL.txt)
!!----------------------------------------------------------------------
CONTAINS
SUBROUTINE tide_init_Wave
!! NB
# if defined key_FES14_tides
# include "tide_FES14.h90"
# else
!! END NB
# include "tide.h90"
# endif
END SUBROUTINE tide_init_Wave
SUBROUTINE tide_harmo( pomega, pvt, put , pcor, ktide ,kc)
!!----------------------------------------------------------------------
!!----------------------------------------------------------------------
INTEGER , DIMENSION(kc), INTENT(in ) :: ktide ! Indice of tidal constituents
INTEGER , INTENT(in ) :: kc ! Total number of tidal constituents
REAL(wp), DIMENSION(kc), INTENT(out) :: pomega ! pulsation in radians/s
REAL(wp), DIMENSION(kc), INTENT(out) :: pvt, put, pcor !
!!----------------------------------------------------------------------
!
CALL astronomic_angle
CALL tide_pulse( pomega, ktide ,kc )
CALL tide_vuf ( pvt, put, pcor, ktide ,kc )
!
END SUBROUTINE tide_harmo
SUBROUTINE astronomic_angle
!!----------------------------------------------------------------------
!! tj is time elapsed since 1st January 1900, 0 hour, counted in julian
!! century (e.g. time in days divide by 36525)
!!----------------------------------------------------------------------
REAL(wp) :: cosI, p, q, t2, t4, sin2I, s2, tgI2, P1, sh_tgn2, at1, at2
REAL(wp) :: zqy , zsy, zday, zdj, zhfrac
!!----------------------------------------------------------------------
!
zqy = AINT( (nyear-1901.)/4. )
zsy = nyear - 1900.
!
zdj = dayjul( nyear, nmonth, nday )
zday = zdj + zqy - 1.
!
zhfrac = nsec_day / 3600.
!
!----------------------------------------------------------------------
! Sh_n Longitude of ascending lunar node
!----------------------------------------------------------------------
sh_N=(259.1560564-19.328185764*zsy-.0529539336*zday-.0022064139*zhfrac)*rad
!----------------------------------------------------------------------
! T mean solar angle (Greenwhich time)
!----------------------------------------------------------------------
sh_T=(180.+zhfrac*(360./24.))*rad
!----------------------------------------------------------------------
! h mean solar Longitude
!----------------------------------------------------------------------
sh_h=(280.1895014-.238724988*zsy+.9856473288*zday+.0410686387*zhfrac)*rad
!----------------------------------------------------------------------
! s mean lunar Longitude
!----------------------------------------------------------------------
sh_s=(277.0256206+129.38482032*zsy+13.176396768*zday+.549016532*zhfrac)*rad
!----------------------------------------------------------------------
! p1 Longitude of solar perigee
!----------------------------------------------------------------------
sh_p1=(281.2208569+.01717836*zsy+.000047064*zday+.000001961*zhfrac)*rad
!----------------------------------------------------------------------
! p Longitude of lunar perigee
!----------------------------------------------------------------------
sh_p=(334.3837214+40.66246584*zsy+.111404016*zday+.004641834*zhfrac)*rad
sh_N = MOD( sh_N ,2*rpi )
sh_s = MOD( sh_s ,2*rpi )
sh_h = MOD( sh_h, 2*rpi )
sh_p = MOD( sh_p, 2*rpi )
sh_p1= MOD( sh_p1,2*rpi )
cosI = 0.913694997 -0.035692561 *cos(sh_N)
sh_I = ACOS( cosI )
sin2I = sin(sh_I)
sh_tgn2 = tan(sh_N/2.0)
at1=atan(1.01883*sh_tgn2)
at2=atan(0.64412*sh_tgn2)
sh_xi=-at1-at2+sh_N
IF( sh_N > rpi ) sh_xi=sh_xi-2.0*rpi
sh_nu = at1 - at2
!----------------------------------------------------------------------
! For constituents l2 k1 k2
!----------------------------------------------------------------------
tgI2 = tan(sh_I/2.0)
P1 = sh_p-sh_xi
t2 = tgI2*tgI2
t4 = t2*t2
sh_x1ra = sqrt( 1.0-12.0*t2*cos(2.0*P1)+36.0*t4 )
p = sin(2.0*P1)
q = 1.0/(6.0*t2)-cos(2.0*P1)
sh_R = atan(p/q)
p = sin(2.0*sh_I)*sin(sh_nu)
q = sin(2.0*sh_I)*cos(sh_nu)+0.3347
sh_nuprim = atan(p/q)
s2 = sin(sh_I)*sin(sh_I)
p = s2*sin(2.0*sh_nu)
q = s2*cos(2.0*sh_nu)+0.0727
sh_nusec = 0.5*atan(p/q)
!
END SUBROUTINE astronomic_angle
SUBROUTINE tide_pulse( pomega, ktide ,kc )
!!----------------------------------------------------------------------
!! *** ROUTINE tide_pulse ***
!!
!! ** Purpose : Compute tidal frequencies
!!----------------------------------------------------------------------
INTEGER , INTENT(in ) :: kc ! Total number of tidal constituents
INTEGER , DIMENSION(kc), INTENT(in ) :: ktide ! Indice of tidal constituents
REAL(wp), DIMENSION(kc), INTENT(out) :: pomega ! pulsation in radians/s
!
INTEGER :: jh
REAL(wp) :: zscale
REAL(wp) :: zomega_T = 13149000.0_wp
REAL(wp) :: zomega_s = 481267.892_wp
REAL(wp) :: zomega_h = 36000.76892_wp
REAL(wp) :: zomega_p = 4069.0322056_wp
REAL(wp) :: zomega_n = 1934.1423972_wp
REAL(wp) :: zomega_p1= 1.719175_wp
!!----------------------------------------------------------------------
!
zscale = rad / ( 36525._wp * 86400._wp )
!
DO jh = 1, kc
pomega(jh) = ( zomega_T * Wave( ktide(jh) )%nT &
& + zomega_s * Wave( ktide(jh) )%ns &
& + zomega_h * Wave( ktide(jh) )%nh &
& + zomega_p * Wave( ktide(jh) )%np &
& + zomega_p1* Wave( ktide(jh) )%np1 ) * zscale
END DO
!
END SUBROUTINE tide_pulse
SUBROUTINE tide_vuf( pvt, put, pcor, ktide ,kc )
!!----------------------------------------------------------------------
!! *** ROUTINE tide_vuf ***
!!
!! ** Purpose : Compute nodal modulation corrections
!!
!! ** Outputs : vt: Phase of tidal potential relative to Greenwich (radians)
!! ut: Phase correction u due to nodal motion (radians)
!! ft: Nodal correction factor
!!----------------------------------------------------------------------
INTEGER , INTENT(in ) :: kc ! Total number of tidal constituents
INTEGER , DIMENSION(kc), INTENT(in ) :: ktide ! Indice of tidal constituents
REAL(wp), DIMENSION(kc), INTENT(out) :: pvt, put, pcor !
!
INTEGER :: jh ! dummy loop index
!!----------------------------------------------------------------------
!
DO jh = 1, kc
! Phase of the tidal potential relative to the Greenwhich
! meridian (e.g. the position of the fictuous celestial body). Units are radian:
pvt(jh) = sh_T * Wave( ktide(jh) )%nT &
& + sh_s * Wave( ktide(jh) )%ns &
& + sh_h * Wave( ktide(jh) )%nh &
& + sh_p * Wave( ktide(jh) )%np &
& + sh_p1* Wave( ktide(jh) )%np1 &
& + Wave( ktide(jh) )%shift * rad
!
! Phase correction u due to nodal motion. Units are radian:
put(jh) = sh_xi * Wave( ktide(jh) )%nksi &
& + sh_nu * Wave( ktide(jh) )%nnu0 &
& + sh_nuprim * Wave( ktide(jh) )%nnu1 &
& + sh_nusec * Wave( ktide(jh) )%nnu2 &
& + sh_R * Wave( ktide(jh) )%R
! Nodal correction factor:
pcor(jh) = nodal_factort( Wave( ktide(jh) )%nformula )
END DO
!
END SUBROUTINE tide_vuf
RECURSIVE FUNCTION nodal_factort( kformula ) RESULT( zf )
!!----------------------------------------------------------------------
!!----------------------------------------------------------------------
INTEGER, INTENT(in) :: kformula
!
REAL(wp) :: zf
REAL(wp) :: zs, zf1, zf2
!!----------------------------------------------------------------------
!
SELECT CASE( kformula )
!
CASE( 0 ) !== formule 0, solar waves
zf = 1.0
!
CASE( 1 ) !== formule 1, compound waves (78 x 78)
zf=nodal_factort(78)
zf = zf * zf
!
CASE ( 2 ) !== formule 2, compound waves (78 x 0) === (78)
zf1= nodal_factort(78)
zf = nodal_factort( 0)
zf = zf1 * zf
!
CASE ( 4 ) !== formule 4, compound waves (78 x 235)
zf1 = nodal_factort( 78)
zf = nodal_factort(235)
zf = zf1 * zf
!
CASE ( 5 ) !== formule 5, compound waves (78 *78 x 235)
zf1 = nodal_factort( 78)
zf = nodal_factort(235)
zf = zf * zf1 * zf1
!
CASE ( 6 ) !== formule 6, compound waves (78 *78 x 0)
zf1 = nodal_factort(78)
zf = nodal_factort( 0)
zf = zf * zf1 * zf1
!
CASE( 7 ) !== formule 7, compound waves (75 x 75)
zf = nodal_factort(75)
zf = zf * zf
!
CASE( 8 ) !== formule 8, compound waves (78 x 0 x 235)
zf = nodal_factort( 78)
zf1 = nodal_factort( 0)
zf2 = nodal_factort(235)
zf = zf * zf1 * zf2
!
CASE( 9 ) !== formule 9, compound waves (78 x 0 x 227)
zf = nodal_factort( 78)
zf1 = nodal_factort( 0)
zf2 = nodal_factort(227)
zf = zf * zf1 * zf2
!
CASE( 10 ) !== formule 10, compound waves (78 x 227)
zf = nodal_factort( 78)
zf1 = nodal_factort(227)
zf = zf * zf1
!
CASE( 11 ) !== formule 11, compound waves (75 x 0)
!!gm bug???? zf 2 fois !
zf = nodal_factort(75)
zf = nodal_factort( 0)
zf = zf * zf1
!
CASE( 12 ) !== formule 12, compound waves (78 x 78 x 78 x 0)
zf1 = nodal_factort(78)
zf = nodal_factort( 0)
zf = zf * zf1 * zf1 * zf1
!
CASE( 13 ) !== formule 13, compound waves (78 x 75)
zf1 = nodal_factort(78)
zf = nodal_factort(75)
zf = zf * zf1
!
CASE( 14 ) !== formule 14, compound waves (235 x 0) === (235)
zf = nodal_factort(235)
zf1 = nodal_factort( 0)
zf = zf * zf1
!
CASE( 15 ) !== formule 15, compound waves (235 x 75)
zf = nodal_factort(235)
zf1 = nodal_factort( 75)
zf = zf * zf1
!
CASE( 16 ) !== formule 16, compound waves (78 x 0 x 0) === (78)
zf = nodal_factort(78)
zf1 = nodal_factort( 0)
zf = zf * zf1 * zf1
!
CASE( 17 ) !== formule 17, compound waves (227 x 0)
zf1 = nodal_factort(227)
zf = nodal_factort( 0)
zf = zf * zf1
!
CASE( 18 ) !== formule 18, compound waves (78 x 78 x 78 )
zf1 = nodal_factort(78)
zf = zf1 * zf1 * zf1
!
CASE( 19 ) !== formule 19, compound waves (78 x 0 x 0 x 0) === (78)
!!gm bug2 ==>>> here identical to formule 16, a third multiplication by zf1 is missing
zf = nodal_factort(78)
zf1 = nodal_factort( 0)
zf = zf * zf1 * zf1
!
!--- NB 11/2017
CASE( 20 ) !== formule 20, compound waves ( 78 x 78 x 78 x 78 )
zf1 = nodal_factort(78)
zf = zf1 * zf1 * zf1 * zf1
!--- END NB
!
CASE( 73 ) !== formule 73
zs = sin(sh_I)
zf = (2./3.-zs*zs)/0.5021
!
CASE( 74 ) !== formule 74
zs = sin(sh_I)
zf = zs * zs / 0.1578
!
CASE( 75 ) !== formule 75
zs = cos(sh_I/2)
zf = sin(sh_I) * zs * zs / 0.3800
!
CASE( 76 ) !== formule 76
zf = sin(2*sh_I) / 0.7214
!
CASE( 77 ) !== formule 77
zs = sin(sh_I/2)
zf = sin(sh_I) * zs * zs / 0.0164
!
CASE( 78 ) !== formule 78
zs = cos(sh_I/2)
zf = zs * zs * zs * zs / 0.9154
!
CASE( 79 ) !== formule 79
zs = sin(sh_I)
zf = zs * zs / 0.1565
!
CASE( 144 ) !== formule 144
zs = sin(sh_I/2)
zf = ( 1-10*zs*zs+15*zs*zs*zs*zs ) * cos(sh_I/2) / 0.5873
!
CASE( 149 ) !== formule 149
zs = cos(sh_I/2)
zf = zs*zs*zs*zs*zs*zs / 0.8758
!
CASE( 215 ) !== formule 215
zs = cos(sh_I/2)
zf = zs*zs*zs*zs / 0.9154 * sh_x1ra
!
CASE( 227 ) !== formule 227
zs = sin(2*sh_I)
zf = sqrt( 0.8965*zs*zs+0.6001*zs*cos (sh_nu)+0.1006 )
!
CASE ( 235 ) !== formule 235
zs = sin(sh_I)
zf = sqrt( 19.0444*zs*zs*zs*zs + 2.7702*zs*zs*cos(2*sh_nu) + .0981 )
!
END SELECT
!
END FUNCTION nodal_factort
FUNCTION dayjul( kyr, kmonth, kday )
!!----------------------------------------------------------------------
!! *** THIS ROUTINE COMPUTES THE JULIAN DAY (AS A REAL VARIABLE)
!!----------------------------------------------------------------------
INTEGER,INTENT(in) :: kyr, kmonth, kday
!
INTEGER,DIMENSION(12) :: idayt, idays
INTEGER :: inc, ji
REAL(wp) :: dayjul, zyq
!
DATA idayt/0.,31.,59.,90.,120.,151.,181.,212.,243.,273.,304.,334./
!!----------------------------------------------------------------------
!
idays(1) = 0.
idays(2) = 31.
inc = 0.
zyq = MOD( kyr-1900. , 4. )
IF( zyq == 0.) inc = 1.
DO ji = 3, 12
idays(ji)=idayt(ji)+inc
END DO
dayjul = idays(kmonth) + kday
!
END FUNCTION dayjul
!!======================================================================
END MODULE tide_mod
MODULE tideini
!!======================================================================
!! *** MODULE tideini ***
!! Initialization of tidal forcing
!!======================================================================
!! History : 1.0 ! 2007 (O. Le Galloudec) Original code
!!----------------------------------------------------------------------
USE oce ! ocean dynamics and tracers variables
USE dom_oce ! ocean space and time domain
USE phycst ! physical constant
USE daymod ! calandar
USE tide_mod !
!
USE in_out_manager ! I/O units
USE iom ! xIOs server
USE ioipsl ! NetCDF IPSL library
USE lbclnk ! ocean lateral boundary conditions (or mpp link)
IMPLICIT NONE
PUBLIC
REAL(wp), PUBLIC, ALLOCATABLE, DIMENSION(:) :: omega_tide !:
REAL(wp), PUBLIC, ALLOCATABLE, DIMENSION(:) :: v0tide !:
REAL(wp), PUBLIC, ALLOCATABLE, DIMENSION(:) :: utide !:
REAL(wp), PUBLIC, ALLOCATABLE, DIMENSION(:) :: ftide !:
LOGICAL , PUBLIC :: ln_tide !:
LOGICAL , PUBLIC :: ln_tide_pot !:
LOGICAL , PUBLIC :: ln_tide_ramp !:
INTEGER , PUBLIC :: nb_harmo !:
INTEGER , PUBLIC :: kt_tide !:
REAL(wp), PUBLIC :: rdttideramp !:
! NB - read love number from namelist
REAL(wp), PUBLIC :: dn_love_number !:
! END NB
INTEGER , PUBLIC, ALLOCATABLE, DIMENSION(:) :: ntide !:
!!----------------------------------------------------------------------
!! NEMO/OPA 3.5 , NEMO Consortium (2013)
!! $Id: tideini.F90 7646 2017-02-06 09:25:03Z timgraham $
!! Software governed by the CeCILL licence (NEMOGCM/NEMO_CeCILL.txt)
!!----------------------------------------------------------------------
CONTAINS
SUBROUTINE tide_init
!!----------------------------------------------------------------------
!! *** ROUTINE tide_init ***
!!----------------------------------------------------------------------
INTEGER :: ji, jk
CHARACTER(LEN=4), DIMENSION(jpmax_harmo) :: clname
INTEGER :: ios ! Local integer output status for namelist read
!
! NB - read love number from namelist
!NAMELIST/nam_tide/ln_tide, ln_tide_pot, ln_tide_ramp, rdttideramp, clname
NAMELIST/nam_tide/ln_tide, ln_tide_pot, ln_tide_ramp, rdttideramp, dn_love_number, clname
! END NB
!!----------------------------------------------------------------------
!
! Read Namelist nam_tide
REWIND( numnam_ref ) ! Namelist nam_tide in reference namelist : Tides
READ ( numnam_ref, nam_tide, IOSTAT = ios, ERR = 901)
901 IF( ios /= 0 ) CALL ctl_nam ( ios , 'nam_tide in reference namelist', lwp )
!
REWIND( numnam_cfg ) ! Namelist nam_tide in configuration namelist : Tides
READ ( numnam_cfg, nam_tide, IOSTAT = ios, ERR = 902 )
902 IF( ios /= 0 ) CALL ctl_nam ( ios , 'nam_tide in configuration namelist', lwp )
IF(lwm) WRITE ( numond, nam_tide )
!
IF (ln_tide) THEN
IF (lwp) THEN
WRITE(numout,*)
WRITE(numout,*) 'tide_init : Initialization of the tidal components'
WRITE(numout,*) '~~~~~~~~~ '
WRITE(numout,*) ' Namelist nam_tide'
WRITE(numout,*) ' Use tidal components : ln_tide = ', ln_tide
WRITE(numout,*) ' Apply astronomical potential : ln_tide_pot = ', ln_tide_pot
! WRITE(numout,*) ' nb_harmo = ', nb_harmo
WRITE(numout,*) ' ln_tide_ramp = ', ln_tide_ramp
! NB - Love number
WRITE(numout,*) ' dn_love_number = ', dn_love_number
! End NB
ENDIF
ELSE
IF(lwp) WRITE(numout,*)
IF(lwp) WRITE(numout,*) 'tide_init : tidal components not used (ln_tide = F)'
IF(lwp) WRITE(numout,*) '~~~~~~~~~ '
RETURN
ENDIF
!
CALL tide_init_Wave
!
nb_harmo=0
DO jk = 1, jpmax_harmo
DO ji = 1,jpmax_harmo
IF( TRIM(clname(jk)) == Wave(ji)%cname_tide ) nb_harmo = nb_harmo + 1
END DO
END DO
IF (ln_tide .and.lwp) WRITE(numout,*) ' nb_harmo = ', nb_harmo
! Ensure that tidal components have been set in namelist_cfg
IF( nb_harmo == 0 ) CALL ctl_stop( 'tide_init : No tidal components set in nam_tide' )
!
IF( ln_tide_ramp.AND.((nitend-nit000+1)*rdt/rday < rdttideramp) ) &
& CALL ctl_stop('rdttideramp must be lower than run duration')
IF( ln_tide_ramp.AND.(rdttideramp<0.) ) &
& CALL ctl_stop('rdttideramp must be positive')
!
ALLOCATE( ntide(nb_harmo) )
DO jk = 1, nb_harmo
DO ji = 1, jpmax_harmo
IF( TRIM(clname(jk)) == Wave(ji)%cname_tide ) THEN
ntide(jk) = ji
EXIT
ENDIF
END DO
END DO
!
ALLOCATE( omega_tide(nb_harmo), v0tide (nb_harmo), &
& utide (nb_harmo), ftide (nb_harmo) )
kt_tide = nit000
!
END SUBROUTINE tide_init
!!======================================================================
END MODULE tideini
MODULE usrdef_istate
!!======================================================================
!! *** MODULE usrdef_istate ***
!!
!! === GYRE configuration ===
!!
!! User defined : set the initial state of a user configuration
!!======================================================================
!! History : NEMO ! 2016-03 (S. Flavoni) Original code
!!----------------------------------------------------------------------
!!----------------------------------------------------------------------
!! usr_def_istate : initial state in Temperature and salinity
!!----------------------------------------------------------------------
USE par_oce ! ocean space and time domain
USE phycst ! physical constants
!
USE in_out_manager ! I/O manager
USE lib_mpp ! MPP library
IMPLICIT NONE
PRIVATE
PUBLIC usr_def_istate ! called in istate.F90
!!----------------------------------------------------------------------
!! NEMO/OPA 4.0 , NEMO Consortium (2016)
!! $Id$
!! Software governed by the CeCILL licence (NEMOGCM/NEMO_CeCILL.txt)
!!----------------------------------------------------------------------
CONTAINS
SUBROUTINE usr_def_istate( pdept, ptmask, pts, pu, pv, pssh )
!!----------------------------------------------------------------------
!! *** ROUTINE usr_def_istate ***
!!
!! ** Purpose : Initialization of the dynamics and tracers
!! Here GYRE configuration example : (double gyre with rotated domain)
!!
!! ** Method : - set temprature field
!! - set salinity field
!!----------------------------------------------------------------------
REAL(wp), DIMENSION(jpi,jpj,jpk) , INTENT(in ) :: pdept ! depth of t-point [m]
REAL(wp), DIMENSION(jpi,jpj,jpk) , INTENT(in ) :: ptmask ! t-point ocean mask [m]
REAL(wp), DIMENSION(jpi,jpj,jpk,jpts), INTENT( out) :: pts ! T & S fields [Celsius ; g/kg]
REAL(wp), DIMENSION(jpi,jpj,jpk) , INTENT( out) :: pu ! i-component of the velocity [m/s]
REAL(wp), DIMENSION(jpi,jpj,jpk) , INTENT( out) :: pv ! j-component of the velocity [m/s]
REAL(wp), DIMENSION(jpi,jpj) , INTENT( out) :: pssh ! sea-surface height
!
INTEGER :: ji, jj, jk ! dummy loop indices
!!----------------------------------------------------------------------
!
IF(lwp) WRITE(numout,*)
IF(lwp) WRITE(numout,*) 'usr_def_istate : analytical definition of initial state '
IF(lwp) WRITE(numout,*) '~~~~~~~~~~~~~~ Ocean at rest, with an horizontally uniform T and S profiles'
!
pu (:,:,:) = 0._wp ! ocean at rest
pv (:,:,:) = 0._wp
pssh(:,:) = 0._wp
!
DO jk = 1, jpk ! horizontally uniform T & S profiles
DO jj = 1, jpj
DO ji = 1, jpi
pts(ji,jj,jk,jp_tem) = 20._wp * ptmask(ji,jj,jk)
pts(ji,jj,jk,jp_sal) = 36.25_wp * ptmask(ji,jj,jk)
END DO
END DO
END DO
!
END SUBROUTINE usr_def_istate
!!======================================================================
END MODULE usrdef_istate
MODULE usrdef_sbc
!!======================================================================
!! *** MODULE usrdef_sbc ***
!!
!! === WAD_TEST_CASES configuration ===
!!
!! User defined : surface forcing of a user configuration
!!======================================================================
!! History : 4.0 ! 2016-03 (S. Flavoni, G. Madec) user defined interface
!!----------------------------------------------------------------------
!!----------------------------------------------------------------------
!! usrdef_sbc : user defined surface bounday conditions in WAD_TEST_CASES case
!!----------------------------------------------------------------------
USE oce ! ocean dynamics and tracers
USE dom_oce ! ocean space and time domain
USE sbc_oce ! Surface boundary condition: ocean fields
USE phycst ! physical constants
!
USE in_out_manager ! I/O manager
USE lib_mpp ! distribued memory computing library
USE lbclnk ! ocean lateral boundary conditions (or mpp link)
USE lib_fortran ! Fortran utilities (allows no signed zero when 'key_nosignedzero' defined)
IMPLICIT NONE
PRIVATE
PUBLIC usrdef_sbc_oce ! routine called in sbcmod module
PUBLIC usrdef_sbc_ice_tau ! routine called by sbcice_lim.F90 for ice dynamics
PUBLIC usrdef_sbc_ice_flx ! routine called by sbcice_lim.F90 for ice thermo
!! * Substitutions
# include "vectopt_loop_substitute.h90"
!!----------------------------------------------------------------------
!! NEMO/OPA 4.0 , NEMO Consortium (2016)
!! $Id$
!! Software governed by the CeCILL licence (NEMOGCM/NEMO_CeCILL.txt)
!!----------------------------------------------------------------------
CONTAINS
SUBROUTINE usrdef_sbc_oce( kt )
!!---------------------------------------------------------------------
!! *** ROUTINE usr_def_sbc ***
!!
!! ** Purpose : provide at each time-step the surface boundary
!! condition, i.e. the momentum, heat and freshwater fluxes.
!!
!! ** Method : all 0 fields, for WAD_TEST_CASES case
!! CAUTION : never mask the surface stress field !
!!
!! ** Action : - set to ZERO all the ocean surface boundary condition, i.e.
!! utau, vtau, taum, wndm, qns, qsr, emp, sfx
!!
!!----------------------------------------------------------------------
INTEGER, INTENT(in) :: kt ! ocean time step
!!---------------------------------------------------------------------
!
IF( kt == nit000 ) THEN
!
IF(lwp) WRITE(numout,*)' usr_sbc : WAD_TEST_CASES case: NO surface forcing'
IF(lwp) WRITE(numout,*)' ~~~~~~~~~~~ utau = vtau = taum = wndm = qns = qsr = emp = sfx = 0'
!
utau(:,:) = 0._wp
vtau(:,:) = 0._wp
taum(:,:) = 0._wp
wndm(:,:) = 0._wp
!
emp (:,:) = 0._wp
sfx (:,:) = 0._wp
qns (:,:) = 0._wp
qsr (:,:) = 0._wp
!
ENDIF
!
END SUBROUTINE usrdef_sbc_oce
SUBROUTINE usrdef_sbc_ice_tau( kt )
INTEGER, INTENT(in) :: kt ! ocean time step
END SUBROUTINE usrdef_sbc_ice_tau
SUBROUTINE usrdef_sbc_ice_flx( kt )
INTEGER, INTENT(in) :: kt ! ocean time step
END SUBROUTINE usrdef_sbc_ice_flx
!!======================================================================
END MODULE usrdef_sbc
......@@ -19,38 +19,5 @@ BoBEAS
| |----fix_elevations.sh
| |____interpolate_gebco.sh
|
|____ARCH
| |____arch-XC_ARCHER.fcm
|____arch_xios
| |____arch-XC_ARCHER.env
| |____arch-XC_ARCHER.fcm
| |____arch-XC_ARCHER.path
|____cpp_MYCONFIG.fcm
!____EXP_README.txt
|____EXP00
| |____1_namelist_cfg
| |____1_namelist_ice_cfg
| |____1_namelist_ice_ref
| |____1_namelist_ref
| |____context_nemo.xml
| |____domain_def_nemo.xml
| |____field_def_nemo-lim.xml
| |____field_def_nemo-opa.xml
| |____field_def_nemo-pisces.xml
| |____file_def_nemo.xml
| |____iodef.xml
| |____namelist_cfg
| |____namelist_ice_cfg
| |____namelist_ice_ref
| |____namelist_pisces_cfg
| |____namelist_pisces_ref
| |____namelist_ref
| |____namelist_top_cfg
| |____namelist_top_ref
| |____runscript
|____MY_SRC
| |____*.F90
|____INPUTS
| |____namelist.bdy
|____README.md
</pre>
module unload anaconda/2.2.0-python2
module load anaconda
git clone https://ashbre@bitbucket.org/jdha/nrct.git $WORK/nrct
module unload anaconda
module load anaconda/2.2.0-python2
yes | conda create --name nrct_tide scipy=0.17.0 numpy matplotlib basemap netcdf4 libgfortran=1.0.0
source activate nrct_tide
yes | conda install -c https://conda.anaconda.org/conda-forge seawater=3.3.4 # Note had to add https path
yes | conda install -c https://conda.anaconda.org/srikanthnagella thredds_crawler
yes | conda install -c https://conda.anaconda.org/srikanthnagella pyjnius
#module load java
LD_LIBRARY_PATH=/opt/java/jdk1.8.0_51/jre/lib/amd64/server/:$LD_LIBRARY_PATH
source deactivate nrct_tide
cd $WORK/nrct/Python
git checkout Generalise-tide-input
python setup.py build
export PYTHONPATH=~/.conda/envs/nrct_tide/lib/python2.7/site-packages/:$PYTHONPATH
#export PYTHONPATH=/work/n01/n01/jelt/jelt-conda/envs/nrct_tide/lib/python2.7/site-packages/:$PYTHONPATH
python setup.py install --prefix ~/.conda/envs/nrct_tide
#python setup.py install --prefix /work/n01/n01/jelt/jelt-conda/envs/nrct_tide
cd $WDIR
export HDF5_INC_DIR=${HDF5_DIR}/include
export HDF5_LIB_DIR=${HDF5_DIR}/lib
export NETCDF_INC_DIR=${NETCDF_DIR}/include
export NETCDF_LIB_DIR=${NETCDF_DIR}/lib
%CCOMPILER CC
%FCOMPILER ftn
%LINKER ftn -nofor-main -v
%BASE_CFLAGS
%PROD_CFLAGS -O3 -D BOOST_DISABLE_ASSERTS
%DEV_CFLAGS -g -traceback
%DEBUG_CFLAGS -DBZ_DEBUG -g -traceback -fno-inline
%BASE_FFLAGS -D__NONE__
%PROD_FFLAGS -O2
%DEV_FFLAGS -g -O2 -traceback
%DEBUG_FFLAGS -g -traceback
%BASE_INC -D__NONE__
%BASE_LD -lstdc++
%CPP CC -EP
%FPP cpp -P
%MAKE gmake
NETCDF_INCDIR="-I $NETCDF_INC_DIR"
NETCDF_LIBDIR='-Wl,"--allow-multiple-definition" -Wl,"-Bstatic" -L $NETCDF_LIB_DIR'
NETCDF_LIB="-lnetcdf -lnetcdff"
MPI_INCDIR=""
MPI_LIBDIR=""
MPI_LIB=""
#HDF5_INCDIR="-I $HDF5_INC_DIR"
HDF5_LIBDIR="-L $HDF5_LIB_DIR"
HDF5_LIB="-lhdf5_hl -lhdf5 -lz"
OASIS_INCDIR=""
OASIS_LIBDIR=""
OASIS_LIB=""
#OASIS_INCDIR="-I$PWD/../../prism/X64/build/lib/psmile.MPI1"
#OASIS_LIBDIR="-L$PWD/../../prism/X64/lib"
#OASIS_LIB="-lpsmile.MPI1 -lmpp_io"
bld::tool::fppkeys key_zdfgls \
key_FES14_tides \
key_diaharm_fast \
key_mpp_mpi \
key_iomput \
key_nosignedzero
Markdown is supported
0% or .
You are about to add 0 people to the discussion. Proceed with caution.
Finish editing this message first!
Please register or to comment