Symbol Description Uses
gravity Acceleration due to constant gravity ( m/s^2 ) 204



File Line number Procedure Code
./model/inc/PARAMS.h 821 NO PROCEDURE
     & gravity, recip_gravity, gBaro,
./model/inc/PARAMS.h 922 NO PROCEDURE
      _RL gravity,       recip_gravity
./pkg/fizhi/fizhi_moist.F 2367 RNEVP
     2   tmfrc,cp,gravity,alhl,gamfac,cldlz,RHCRIT,offset,alpha)
./pkg/fizhi/fizhi_moist.F 2379 RNEVP
      _RL tmscl,tmfrc,cp,gravity,alhl,gamfac,offset,alpha
./pkg/fizhi/fizhi_moist.F 2430 RNEVP
       CPOG    = cp/gravity
./pkg/fizhi/fizhi_step_diag.F 42 FIZHI_STEP_DIAG
      _RL getcon, gravity
./pkg/fizhi/fizhi_step_diag.F 430 FIZHI_STEP_DIAG
       gravity = getcon('GRAVITY')
./pkg/fizhi/fizhi_step_diag.F 446 FIZHI_STEP_DIAG
       tmpdiag(i,j) = qbar(i,j)*10. _d 0 /gravity
./pkg/ggl90/ggl90_calc.F 218 GGL90_CALC
         Nsquare(i,j,k) = gravity*gravitySign*recip_rhoConst
./pkg/ggl90/ggl90_idemix.F 115 GGL90_IDEMIX
         Nsquare(i,j,k) = gravity*gravitySign*recip_rhoConst
./pkg/gmredi/gmredi_calc_psi_bvp.F 247 GMREDI_CALC_PSI_BVP
        tmpFac = SQRT(gravity/rhoConst)
./pkg/gmredi/gmredi_calc_tensor.F 384 GMREDI_CALC_TENSOR
             M2loc = gravity*recip_rhoConst*dSigmaH
./pkg/gmredi/gmredi_calc_tensor.F 386 GMREDI_CALC_TENSOR
             N2loc = -gravity*recip_rhoConst*dSigmaR
./pkg/gmredi/gmredi_calc_tensor.F 482 GMREDI_CALC_TENSOR
         N2loc = -gravity*recip_rhoConst*dSigmaDr(i,j)
./pkg/gmredi/gmredi_k3d.F 248 GMREDI_K3D
      g_reciprho_sq = (gravity*recip_rhoConst)**2
./pkg/gmredi/gmredi_k3d.F 423 GMREDI_K3D
         N2(i,j,k) = -gravity*recip_rhoConst*sigmaR(i,j,k)
./pkg/gmredi/gmredi_k3d.F 437 GMREDI_K3D
      maxDRhoDz = -rhoConst*GM_K3D_minN2/gravity
./pkg/gmredi/gmredi_readparms.F 215 GMREDI_READPARMS
        GM_BVP_cHat2Min = GM_BVP_cMin**2*rhoConst/gravity
./pkg/gmredi/submeso_calc_psi.F 128 SUBMESO_CALC_PSI
          dBuoyX_Hu(i,j)= -dBuoyX_Hu(i,j)*gravity*recip_rhoConst
./pkg/gmredi/submeso_calc_psi.F 129 SUBMESO_CALC_PSI
          dBuoyY_Hv(i,j)= -dBuoyY_Hv(i,j)*gravity*recip_rhoConst
./pkg/gmredi/submeso_calc_psi.F 130 SUBMESO_CALC_PSI
          NHmixLay(i,j) = SQRT( NHmixLay(i,j)*gravity*recip_rhoConst
./pkg/kl10/kl10_calc.F 129 KL10_CALC
            b0 = MAX(-gravity*mass2rUnit*
./pkg/kl10/kl10_calc.F 139 KL10_CALC
                  buoyFreqf = -gravity*mass2rUnit*
./pkg/kl10/kl10_calc.F 143 KL10_CALC
                  buoyFreqf = -gravity*mass2rUnit*
./pkg/kpp/kpp_forcing_surf.F 212 KPP_FORCING_SURF
        bo(I,J) = - gravity *
./pkg/kpp/kpp_forcing_surf.F 217 KPP_FORCING_SURF
        bosol(I,J) = gravity * TTALPHA(I,J,1) * Qsw(i,j,bi,bj) *
./pkg/kpp/kpp_forcing_surf.F 232 KPP_FORCING_SURF
              temparray(I,J) = - gravity *
./pkg/kpp/kpp_forcing_surf.F 246 KPP_FORCING_SURF
           boplume(I,J,1) = - gravity * SSBETA(I,J,1)
./pkg/kpp/kpp_routines.F 1804 STATEKPP
               DBLOC(I,J,K-1) = gravity * (RHOK(I,J) - RHOKM1(I,J)) /
./pkg/kpp/kpp_routines.F 1806 STATEKPP
               DBSFC(I,J,K)   = gravity * (RHOK(I,J) - RHO1K (I,J)) /
./model/src/calc_grad_phi_hyd.F 167 CALC_GRAD_PHI_HYD
        factorZ = gravity*recip_rhoConst*recip_rhoFacC(k)*0.5 _d 0
./model/src/calc_phi_hyd.F 213 CALC_PHI_HYD
     &                      *gravity*alphaRho(i,j)*recip_rhoConst
./model/src/calc_phi_hyd.F 232 CALC_PHI_HYD
     &              + halfRL*drF(k)*gravFacC(k)*gravity
./model/src/calc_phi_hyd.F 235 CALC_PHI_HYD
     &                     + drF(k)*gravFacC(k)*gravity
./model/src/calc_phi_hyd.F 247 CALC_PHI_HYD
            phiHydC(i,j) = ddRloc*gravFacC(k)*gravity
./model/src/calc_phi_hyd.F 251 CALC_PHI_HYD
     &              + halfRL*drF(k)*gravFacC(k)*gravity
./model/src/calc_phi_hyd.F 255 CALC_PHI_HYD
     &              + halfRL*drF(k)*gravFacC(k)*gravity
./model/src/calc_phi_hyd.F 278 CALC_PHI_HYD
     &             + dRlocM*gravity*alphaRho(i,j)*recip_rhoConst
./model/src/calc_phi_hyd.F 280 CALC_PHI_HYD
     &             + dRlocP*gravity*alphaRho(i,j)*recip_rhoConst
./model/src/calc_phi_hyd.F 295 CALC_PHI_HYD
     &                    )*gravity*alphaRho(i,j)*recip_rhoConst
./model/src/calc_phi_hyd.F 298 CALC_PHI_HYD
     &             + dRlocM*gravity*alphaRho(i,j)*recip_rhoConst
./model/src/calc_phi_hyd.F 301 CALC_PHI_HYD
     &             + dRlocP*gravity*alphaRho(i,j)*recip_rhoConst
./model/src/config_summary.F 317 CONFIG_SUMMARY
      CALL WRITE_0D_RL( gravity, INDEX_NONE,'gravity =',
./pkg/my82/my82_ri_number.F 115 MY82_RI_NUMBER
        buoyFreq(I,J) = gravity*mass2rUnit *
./pkg/ocn_compon_interf/ocn_apply_import.F 134 OCN_APPLY_IMPORT
     &                 + gravity*seaIceMass(i,j,bi,bj)*recip_rhoConst
./pkg/ocn_compon_interf/ocn_apply_import.F 141 OCN_APPLY_IMPORT
     &                 + gravity*seaIceMass(i,j,bi,bj)*recip_rhoConst
./model/src/diags_phi_hyd.F 112 DIAGS_PHI_HYD
           dPhiRef =( Ro_surf(i,j,bi,bj)-rC(k) )*gravity
./model/src/diags_phi_hyd.F 84 DIAGS_PHI_HYD
           dPhiRef = phiRef(2*k) - gravity*topoZ(i,j,bi,bj)
./model/src/diags_phi_rlow.F 113 DIAGS_PHI_RLOW
     &                   )*gravity*alphRho(i,j)*recip_rhoConst
./model/src/diags_phi_rlow.F 146 DIAGS_PHI_RLOW
           dPhiRef = phiRef(2*k+1) - gravity*topoZ(i,j,bi,bj)
./model/src/diags_phi_rlow.F 173 DIAGS_PHI_RLOW
     &              *gravity
./model/src/diags_phi_rlow.F 91 DIAGS_PHI_RLOW
     &        + ddRloc*gravFacC(k)*gravity*alphRho(i,j)*recip_rhoConst
./pkg/opps/opps_calc.F 247 OPPS_CALC
         wsqr = wsqr - wsqr*abs(entrainrate)+ gravity*
./pkg/pp81/pp81_ri_number.F 119 PP81_RI_NUMBER
        buoyFreq = - gravity*mass2rUnit *
./model/src/external_forcing_surf.F 363 EXTERNAL_FORCING_SURF
     &                          +sIceLoad(i,j,bi,bj)*gravity
./model/src/find_hyd_press_1d.F 104 FIND_HYD_PRESS_1D
     &              + rhoCen(k)*gravity*gravFacF(k)*dRlocM
./model/src/find_hyd_press_1d.F 106 FIND_HYD_PRESS_1D
     &              + rhoCen(k)*gravity*gravFacF(k+1)*dRlocP
./model/src/find_hyd_press_1d.F 93 FIND_HYD_PRESS_1D
     &              + rhoCen(k)*gravity*gravFacC(k)*drF(k)*halfRL
./model/src/find_hyd_press_1d.F 95 FIND_HYD_PRESS_1D
     &              + rhoCen(k)*gravity*gravFacC(k)*drF(k)
./pkg/seaice/dynsolver.F 180 DYNSOLVER
     &                      +sIceLoad(i,j,bi,bj)*gravity
./pkg/seaice/seaice_calc_ice_strength.F 168 SEAICE_CALC_ICE_STRENGTH
       tmpscal1 = SEAICE_cf*0.5*gravity*(rhoConst-SEAICE_rhoIce)
./pkg/seaice/seaice_dynsolver.F 219 SEAICE_DYNSOLVER
     &                      +sIceLoad(i,j,bi,bj)*gravity
./pkg/shelfice/shelfice_init_fixed.F 180 SHELFICE_INIT_FIXED
           shelficeLoadAnomaly(i,j,bi,bj) = gravity
./pkg/shelfice/shelfice_thermodynamics.F 582 SHELFICE_THERMODYNAMICS
           shelficeLoadAnomaly(i,j,bi,bj) = gravity
./pkg/streamice/streamice_driving_stress.F 118 STREAMICE_DRIVING_STRESS
     &       gravity *
./pkg/streamice/streamice_driving_stress.F 126 STREAMICE_DRIVING_STRESS
     &       streamice_density * gravity * 
./pkg/streamice/streamice_driving_stress.F 147 STREAMICE_DRIVING_STRESS
     &        gravity * 
./pkg/streamice/streamice_driving_stress.F 165 STREAMICE_DRIVING_STRESS
     &         streamice_density_firn * gravity *
./pkg/streamice/streamice_driving_stress.F 170 STREAMICE_DRIVING_STRESS
     &         0.25 * dyG(i,j,bi,bj) * gravity * (
./pkg/streamice/streamice_driving_stress.F 184 STREAMICE_DRIVING_STRESS
     &        streamice_density * gravity *
./pkg/streamice/streamice_driving_stress.F 210 STREAMICE_DRIVING_STRESS
     &        gravity *
./pkg/streamice/streamice_driving_stress.F 228 STREAMICE_DRIVING_STRESS
     &         streamice_density_firn * gravity *
./pkg/streamice/streamice_driving_stress.F 233 STREAMICE_DRIVING_STRESS
     &         0.25 * dyG(i,j,bi,bj) * gravity * (
./pkg/streamice/streamice_driving_stress.F 247 STREAMICE_DRIVING_STRESS
     &        streamice_density * gravity *
./pkg/streamice/streamice_driving_stress.F 268 STREAMICE_DRIVING_STRESS
     &       gravity *
./pkg/streamice/streamice_driving_stress.F 275 STREAMICE_DRIVING_STRESS
     &       streamice_density * gravity *
./pkg/streamice/streamice_driving_stress.F 295 STREAMICE_DRIVING_STRESS
     &        gravity * 
./pkg/streamice/streamice_driving_stress.F 313 STREAMICE_DRIVING_STRESS
     &         streamice_density_firn * gravity *
./pkg/streamice/streamice_driving_stress.F 318 STREAMICE_DRIVING_STRESS
     &         0.25 * dyG(i,j-1,bi,bj) * gravity * (
./pkg/streamice/streamice_driving_stress.F 332 STREAMICE_DRIVING_STRESS
     &        streamice_density * gravity *
./pkg/streamice/streamice_driving_stress.F 359 STREAMICE_DRIVING_STRESS
     &        gravity *
./pkg/streamice/streamice_driving_stress.F 376 STREAMICE_DRIVING_STRESS
     &         streamice_density_firn * gravity *
./pkg/streamice/streamice_driving_stress.F 381 STREAMICE_DRIVING_STRESS
     &         0.25 * dyG(i,j-1,bi,bj) * gravity * (
./pkg/streamice/streamice_driving_stress.F 395 STREAMICE_DRIVING_STRESS
     &        streamice_density * gravity *
./pkg/streamice/streamice_driving_stress.F 419 STREAMICE_DRIVING_STRESS
     &       gravity *
./pkg/streamice/streamice_driving_stress.F 426 STREAMICE_DRIVING_STRESS
     &       streamice_density * gravity *
./pkg/streamice/streamice_driving_stress.F 446 STREAMICE_DRIVING_STRESS
     &        gravity * 
./pkg/streamice/streamice_driving_stress.F 463 STREAMICE_DRIVING_STRESS
     &         streamice_density_firn * gravity *
./pkg/streamice/streamice_driving_stress.F 468 STREAMICE_DRIVING_STRESS
     &         0.25 * dxG(i,j,bi,bj) * gravity * (
./pkg/streamice/streamice_driving_stress.F 482 STREAMICE_DRIVING_STRESS
     &        streamice_density * gravity *
./pkg/streamice/streamice_driving_stress.F 508 STREAMICE_DRIVING_STRESS
     &        gravity *
./pkg/streamice/streamice_driving_stress.F 526 STREAMICE_DRIVING_STRESS
     &         streamice_density_firn * gravity *
./pkg/streamice/streamice_driving_stress.F 531 STREAMICE_DRIVING_STRESS
     &         0.25 * dxG(i,j,bi,bj) * gravity * (
./pkg/streamice/streamice_driving_stress.F 545 STREAMICE_DRIVING_STRESS
     &        streamice_density * gravity *
./pkg/streamice/streamice_driving_stress.F 566 STREAMICE_DRIVING_STRESS
     &       gravity *
./pkg/streamice/streamice_driving_stress.F 573 STREAMICE_DRIVING_STRESS
     &       streamice_density * gravity *
./pkg/streamice/streamice_driving_stress.F 594 STREAMICE_DRIVING_STRESS
     &        gravity * 
./pkg/streamice/streamice_driving_stress.F 611 STREAMICE_DRIVING_STRESS
     &         streamice_density_firn * gravity *
./pkg/streamice/streamice_driving_stress.F 616 STREAMICE_DRIVING_STRESS
     &         0.25 * dxG(i-1,j,bi,bj) * gravity * (
./pkg/streamice/streamice_driving_stress.F 629 STREAMICE_DRIVING_STRESS
     &        streamice_density * gravity *
./pkg/streamice/streamice_driving_stress.F 656 STREAMICE_DRIVING_STRESS
     &        gravity *
./pkg/streamice/streamice_driving_stress.F 673 STREAMICE_DRIVING_STRESS
     &         streamice_density_firn * gravity *
./pkg/streamice/streamice_driving_stress.F 678 STREAMICE_DRIVING_STRESS
     &         0.25 * dxG(i-1,j,bi,bj) * gravity * (
./pkg/streamice/streamice_driving_stress.F 691 STREAMICE_DRIVING_STRESS
     &        streamice_density * gravity *
./pkg/streamice/streamice_driving_stress_fd.F 173 STREAMICE_DRIVING_STRESS_FD
     &       gravity * streamice_density * 
./pkg/streamice/streamice_driving_stress_fd.F 179 STREAMICE_DRIVING_STRESS_FD
     &       gravity * streamice_density * 
./pkg/streamice/streamice_driving_stress_fd.F 189 STREAMICE_DRIVING_STRESS_FD
     &       gravity * streamice_density * 
./pkg/streamice/streamice_driving_stress_fd.F 195 STREAMICE_DRIVING_STRESS_FD
     &       gravity * streamice_density * 
./pkg/streamice/streamice_driving_stress_fd.F 205 STREAMICE_DRIVING_STRESS_FD
     &       gravity * streamice_density * 
./pkg/streamice/streamice_driving_stress_fd.F 211 STREAMICE_DRIVING_STRESS_FD
     &       gravity * streamice_density * 
./pkg/streamice/streamice_driving_stress_fd.F 221 STREAMICE_DRIVING_STRESS_FD
     &       gravity * streamice_density * 
./pkg/streamice/streamice_driving_stress_fd.F 227 STREAMICE_DRIVING_STRESS_FD
     &       gravity * streamice_density * 
./pkg/streamice/streamice_driving_stress_fd.F 254 STREAMICE_DRIVING_STRESS_FD
     &        gravity * 
./pkg/streamice/streamice_driving_stress_fd.F 268 STREAMICE_DRIVING_STRESS_FD
     &        streamice_density * gravity *
./pkg/streamice/streamice_driving_stress_fd.F 291 STREAMICE_DRIVING_STRESS_FD
     &        gravity * 
./pkg/streamice/streamice_driving_stress_fd.F 305 STREAMICE_DRIVING_STRESS_FD
     &        streamice_density * gravity *
./pkg/streamice/streamice_driving_stress_fd.F 324 STREAMICE_DRIVING_STRESS_FD
     &       gravity * streamice_density * 
./pkg/streamice/streamice_driving_stress_fd.F 330 STREAMICE_DRIVING_STRESS_FD
     &       gravity * streamice_density * 
./pkg/streamice/streamice_driving_stress_fd.F 340 STREAMICE_DRIVING_STRESS_FD
     &       gravity * streamice_density * 
./pkg/streamice/streamice_driving_stress_fd.F 346 STREAMICE_DRIVING_STRESS_FD
     &       gravity * streamice_density * 
./pkg/streamice/streamice_driving_stress_fd.F 356 STREAMICE_DRIVING_STRESS_FD
     &       gravity * streamice_density * 
./pkg/streamice/streamice_driving_stress_fd.F 362 STREAMICE_DRIVING_STRESS_FD
     &       gravity * streamice_density * 
./pkg/streamice/streamice_driving_stress_fd.F 372 STREAMICE_DRIVING_STRESS_FD
     &       gravity * streamice_density * 
./pkg/streamice/streamice_driving_stress_fd.F 378 STREAMICE_DRIVING_STRESS_FD
     &       gravity * streamice_density * 
./pkg/streamice/streamice_driving_stress_fd.F 405 STREAMICE_DRIVING_STRESS_FD
     &        gravity * 
./pkg/streamice/streamice_driving_stress_fd.F 419 STREAMICE_DRIVING_STRESS_FD
     &        streamice_density * gravity *
./pkg/streamice/streamice_driving_stress_fd.F 442 STREAMICE_DRIVING_STRESS_FD
     &        gravity * 
./pkg/streamice/streamice_driving_stress_fd.F 456 STREAMICE_DRIVING_STRESS_FD
     &        streamice_density * gravity *
./pkg/streamice/streamice_driving_stress_ppm.F 101 STREAMICE_DRIVING_STRESS_PPM
     &          0.25 * streamice_density * gravity * 
./pkg/streamice/streamice_driving_stress_ppm.F 129 STREAMICE_DRIVING_STRESS_PPM
     &          0.25 * streamice_density * gravity * 
./pkg/streamice/streamice_driving_stress_ppm.F 147 STREAMICE_DRIVING_STRESS_PPM
     &          streamice_density * gravity * (1./6.) *
./pkg/streamice/streamice_driving_stress_ppm.F 160 STREAMICE_DRIVING_STRESS_PPM
     &          streamice_density * gravity * (1./6.) *
./pkg/streamice/streamice_driving_stress_ppm.F 192 STREAMICE_DRIVING_STRESS_PPM
     &           0.25 * streamice_density * gravity * 
./pkg/streamice/streamice_driving_stress_ppm.F 226 STREAMICE_DRIVING_STRESS_PPM
     &          0.25 * streamice_density * gravity * 
./pkg/streamice/streamice_driving_stress_ppm.F 255 STREAMICE_DRIVING_STRESS_PPM
     &          0.25 * streamice_density * gravity * 
./pkg/streamice/streamice_driving_stress_ppm.F 273 STREAMICE_DRIVING_STRESS_PPM
     &          streamice_density * gravity * (1./6.) *
./pkg/streamice/streamice_driving_stress_ppm.F 286 STREAMICE_DRIVING_STRESS_PPM
     &          streamice_density * gravity * (1./6.) *
./pkg/streamice/streamice_driving_stress_ppm.F 318 STREAMICE_DRIVING_STRESS_PPM
     &           0.25 * streamice_density * gravity * 
./pkg/streamice/streamice_driving_stress_ppm.F 347 STREAMICE_DRIVING_STRESS_PPM
            neu_val = .5 * gravity * 
./pkg/streamice/streamice_driving_stress_ppm.F 351 STREAMICE_DRIVING_STRESS_PPM
            neu_val = .5 * gravity * 
./pkg/streamice/streamice_driving_stress_ppm.F 356 STREAMICE_DRIVING_STRESS_PPM
            neu_val = .5 * gravity * 
./pkg/streamice/streamice_forced_buttress.F 110 STREAMICE_FORCED_BUTTRESS
     &         streamice_density_firn * gravity *
./pkg/streamice/streamice_forced_buttress.F 114 STREAMICE_FORCED_BUTTRESS
              unconf_stress = gravity * (
./pkg/streamice/streamice_forced_buttress.F 127 STREAMICE_FORCED_BUTTRESS
              unconf_stress = streamice_density * gravity *
./pkg/streamice/streamice_forced_buttress.F 95 STREAMICE_FORCED_BUTTRESS
              unconf_stress = gravity *
./model/src/ini_p_ground.F 194 INI_P_GROUND
     &               - gravity*( phiLoc - zLoc )/thetaHvR(k)
./model/src/ini_p_ground.F 344 INI_P_GROUND
           phi0surf(i,j,bi,bj) = gravity*(zLoc - Hfld(i,j,bi,bj))
./model/src/ini_parms.F 1450 INI_PARMS
         mass2rUnit = gravity
./model/src/ini_parms.F 183 INI_PARMS
     & gravity, gBaro, gravityFile, rhonil, tAlpha, sBeta,
./model/src/ini_parms.F 447 INI_PARMS
      IF ( gBaro .EQ. UNSET_RL ) gBaro=gravity
./model/src/ini_parms.F 657 INI_PARMS
      IF ( gravity .LE. 0. ) THEN
./model/src/ini_parms.F 664 INI_PARMS
       recip_gravity = 1. _d 0 / gravity
./verification/dome/code/obcs_calc.F 62 OBCS_CALC
      gp_inflow=tAlpha*gravity*dTemp
./verification/internal_wave/code/obcs_calc.F 136 OBCS_CALC
     & *sqrt(strat/(tAlpha*gravity))
./verification/internal_wave/code/obcs_calc.F 59 OBCS_CALC
      strat = 1.0 _d -6 / (gravity*tAlpha)
./verification/tidal_basin_2d/code/external_forcing.F 97 EXTERNAL_FORCING_U
     &   +gravity*tidal_Hscale*
./model/src/set_defaults.F 105 SET_DEFAULTS
      gravity             = 9.81 _d 0
./model/src/set_ref_state.F 100 SET_REF_STATE
     &                  + rhoConst*(rF(k+1)-rF(1))*gravity*gravitySign
./model/src/set_ref_state.F 105 SET_REF_STATE
     &                           + halfRL*drF(k)*gravity*gravFacC(k)
./model/src/set_ref_state.F 106 SET_REF_STATE
          phiRef(2*k+1) = phiRef(2*k-1) + drF(k)*gravity*gravFacC(k)
./model/src/set_ref_state.F 111 SET_REF_STATE
         phiRef(2)   = phiRef(1) + drC(1)*gravity*gravFacF(1)
./model/src/set_ref_state.F 114 SET_REF_STATE
     &                           + halfRL*drC(k)*gravity*gravFacF(k)
./model/src/set_ref_state.F 115 SET_REF_STATE
          phiRef(2*k)   = phiRef(2*k-2) + drC(k)*gravity*gravFacF(k)
./model/src/set_ref_state.F 118 SET_REF_STATE
         phiRef(2*k+1) = phiRef(2*k) + drC(k+1)*gravity*gravFacF(k+1)
./model/src/set_ref_state.F 125 SET_REF_STATE
        phiRef(2*Nr+1) = seaLev_Z*gravity
./model/src/set_ref_state.F 199 SET_REF_STATE
     &               *recip_rhoConst*gravity*gravFacF(k)
./model/src/set_ref_state.F 205 SET_REF_STATE
     &                 *rhoNil*recip_rhoConst*gravity*gravFacF(k)
./model/src/set_ref_state.F 243 SET_REF_STATE
          wUnit2rVel(k) = gravity*rhoLoc
./model/src/set_ref_state.F 277 SET_REF_STATE
            wUnit2rVel(k) = gravity
./model/src/set_ref_state.F 286 SET_REF_STATE
       phiRef(1) = seaLev_Z*gravity
./model/src/set_ref_state.F 91 SET_REF_STATE
     &                  + (rC(k) - rF(1))*gravity*gravitySign
./model/src/set_ref_state.F 93 SET_REF_STATE
     &                  + (rF(k+1)-rF(1))*gravity*gravitySign
./model/src/set_ref_state.F 98 SET_REF_STATE
     &                  + rhoConst*(rC(k) - rF(1))*gravity*gravitySign
./verification/tutorial_global_oce_optim/code_ad/external_forcing_surf.F 366 EXTERNAL_FORCING_SURF
     &                          +sIceLoad(i,j,bi,bj)*gravity
./verification/tutorial_global_oce_optim/code_oad/external_forcing_surf.F 366 EXTERNAL_FORCING_SURF
     &                          +sIceLoad(i,j,bi,bj)*gravity
./pkg/aim_v23/aim_do_physics.F 135 AIM_DO_PHYSICS
           PHI0(I2) = gravity*topoZ(i,j,bi,bj)
./pkg/aim_v23/aim_tendency_apply.F 114 AIM_TENDENCY_APPLY_U
     &                + uStr_tmp*gravity*recip_drF(k)
./pkg/aim_v23/aim_tendency_apply.F 137 AIM_TENDENCY_APPLY_U
     &                + uStr_tmp*gravity*recip_drF(k)
./pkg/aim_v23/aim_tendency_apply.F 302 AIM_TENDENCY_APPLY_V
     &                + vStr_tmp*gravity*recip_drF(k)
./pkg/aim_v23/aim_tendency_apply.F 325 AIM_TENDENCY_APPLY_V
     &                + vStr_tmp*gravity*recip_drF(k)
./pkg/aim_v23/phy_inphys.F 65 INPHYS
      GG = gravity
./pkg/bulk_force/bulkf_formula_lanl.F 132 BULKF_FORMULA_LANL
              czol = zref*xkar*gravity
./pkg/bulk_force/bulkf_formula_lay.F 142 BULKF_FORMULA_LAY
              czol = zref*xkar*gravity
./pkg/cheapaml/cheapaml.F 478 CHEAPAML
     &          **(gravity/gamma_blk/gasR)
./pkg/cheapaml/cheapaml_coare3_flux.F 113 CHEAPAML_COARE3_FLUX
      cwave=gravity*wavesp(i,j,bi,bj)/twoPI
./pkg/cheapaml/cheapaml_coare3_flux.F 133 CHEAPAML_COARE3_FLUX
      zo10= 0.011 _d 0*usr*usr/gravity+0.11 _d 0*visa/usr
./pkg/cheapaml/cheapaml_coare3_flux.F 148 CHEAPAML_COARE3_FLUX
      Ribu=-gravity*zu*(Dt+0.61 _d 0*tta*Dq)/(tta*Du**2)
./pkg/cheapaml/cheapaml_coare3_flux.F 177 CHEAPAML_COARE3_FLUX
        zo=charn*usr*usr/gravity + 0.11 _d 0*visa/usr    !after Smith 1988
./pkg/cheapaml/cheapaml_coare3_flux.F 209 CHEAPAML_COARE3_FLUX
       zL=xkar*gravity*zu*( tsr*(1.+0.61 _d 0*q)+0.61 _d 0*tta*qsr )
./pkg/cheapaml/cheapaml_coare3_flux.F 217 CHEAPAML_COARE3_FLUX
       Bf=-gravity/tta*usr*(tsr+0.61 _d 0*tta*qsr)
./pkg/cheapaml/cheapaml_lanl_flux.F 134 CHEAPAML_LANL_FLUX
     &     **(gravity/gamma_blk/gasR)
./pkg/cheapaml/cheapaml_lanl_flux.F 211 CHEAPAML_LANL_FLUX
                 z100ol   = 100. _d 0 *xkar*gravity/ustar**2 *(tstar/t0
./pkg/cheapaml/cheapaml_lanl_flux.F 92 CHEAPAML_LANL_FLUX
              czol = zref*xkar*gravity
./pkg/down_slope/dwnslp_calc_flow.F 122 DWNSLP_CALC_FLOW
     &             *DWNSLP_rec_mu*gravity*dRhoH*recip_rhoConst
./pkg/ebm/ebm_atmosphere.F 188 EBM_ATMOSPHERE
     &        (gravity*f0*DTDy35(no_so))
./pkg/ebm/ebm_atmosphere.F 191 EBM_ATMOSPHERE
          C = 0.6 _d 0 *gravity*kappa*kappa*Nw/
./pkg/ecco/cost_averagesfields.F 624 COST_AVERAGESFIELDS
                  prmm = totPhiHyd(i,j,k,bi,bj)/gravity
./pkg/ecco/cost_averagesfields.F 630 COST_AVERAGESFIELDS
     &                  -rC(k)*gravity )
./pkg/ecco/cost_averagesfields.F 632 COST_AVERAGESFIELDS
                  prmm = prmm*0.0001/gravity
./pkg/ecco/cost_gencost_customize.F 144 COST_GENCOST_CUSTOMIZE
     &       + sterGloH * gravity
./pkg/ecco/cost_obcs_ageos.F 279 COST_OBCS_AGEOS
     &                        * gravity / f0 / rhonil
./pkg/ecco/cost_obcs_ageos.F 350 COST_OBCS_AGEOS
     &                        * gravity / f0 /rhonil
./pkg/ecco/cost_obcs_ageos.F 418 COST_OBCS_AGEOS
     &                        * gravity / f0 / rhonil
./pkg/ecco/cost_obcs_ageos.F 485 COST_OBCS_AGEOS
     &                        * gravity / f0 /rhonil