Skip to content
Open
Show file tree
Hide file tree
Changes from all commits
Commits
File filter

Filter by extension

Filter by extension

Conversations
Failed to load comments.
Loading
Jump to
Jump to file
Failed to load files.
Loading
Diff view
Diff view
37 changes: 37 additions & 0 deletions components/homme/cmake/machineFiles/greatlakes.cmake
Original file line number Diff line number Diff line change
@@ -0,0 +1,37 @@
# CMake initial cache file for Linux 64bit RHEL7/CENTOS7
# tested with stock gcc/gfortran and packages from EPEL:
# openmpi-devel
# blas-devel
# lapack-devel
# netcdf-fortran-devel
#
#
SET (CMAKE_Fortran_COMPILER mpif90 CACHE FILEPATH "")
SET (CMAKE_C_COMPILER mpicc CACHE FILEPATH "")
SET (CMAKE_CXX_COMPILER mpicc CACHE FILEPATH "")
SET (NetCDF_C $ENV{NETCDF_C_PATH} CACHE FILEPATH "")
SET (NetCDF_C_LIBRARY $ENV{NETCDF_C_PATH}/lib/libnetcdf.so CACHE FILEPATH "")
SET (NetCDF_C_INCLUDE_DIR $ENV{NETCDF_C_PATH}/include CACHE FILEPATH "")
SET (NetCDF_Fortran $ENV{NETCDF_F_PATH} CACHE FILEPATH "")

SET (NetCDF_Fortran_PATH $ENV{NETCDF_F_PATH} CACHE FILEPATH "")
SET (NetCDF_Fortran_LIBRARY $ENV{NETCDF_F_PATH}/lib/libnetcdff.so CACHE FILEPATH "")
SET (NetCDF_Fortran_INCLUDE_DIR $ENV{NETCDF_F_PATH}/include CACHE FILEPATH "")
SET (HDF5_C_LIBRARY $ENV{HDF5_PATH}/lib/libhdf5.so CACHE FILEPATH "")
SET (HDF5_C_INCLUDE_DIR $ENV{HDF5_PATH}/include CACHE FILEPATH "")
SET (HDF5_HL_LIBRARY $ENV{HDF5_PATH}/lib/libhdf5_hl.so CACHE FILEPATH "")
SET (HDF5_HL_INCLUDE_DIR $ENV{HDF5_PATH}/include CACHE FILEPATH "")
SET (PNETCDF_DIR $ENV{PNETCDF_PATH} CACHE FILEPATH "")






SET (WITH_PNETCDF TRUE CACHE FILEPATH "")

# hack until findnetcdf is updated to look for netcdf.mod
#SET (ADD_Fortran_FLAGS $ENV{NETCDF_F_PATH}/include CACHE STRING "")

SET (USE_QUEUING FALSE CACHE BOOL "")
SET (HOMME_FIND_BLASLAPACK ON CACHE BOOL "")
2 changes: 1 addition & 1 deletion components/homme/src/arkode/theta-l/arkode_interface.F90
Original file line number Diff line number Diff line change
Expand Up @@ -248,7 +248,7 @@ function FColumnSolSolve(b, t, y, gamma, x) result(ierr)
use kinds, only: real_kind
use HommeNVector, only: NVec_t
use hybvcoord_mod, only: hvcoord_t
use physical_constants, only: g
use physical_constants, only: gravit
use dimensions_mod, only: np, nlev, nlevp
use parallel_mod, only: abortmp
use iso_c_binding
Expand Down
16 changes: 8 additions & 8 deletions components/homme/src/implicit_mod.F90
Original file line number Diff line number Diff line change
Expand Up @@ -9,7 +9,7 @@ subroutine advance_imp_nonstag(elem, edge1, edge2, edge3, red, deriv, cg, &

use kinds, only : real_kind
use dimensions_mod, only : np, nlev, nvar
use physical_constants, only : g
use physical_constants, only : gravit
use element_mod, only : element_t
use parallel_mod, only : parallel_t, abortmp
use edge_mod, only : edgevpack, edgevunpack
Expand Down Expand Up @@ -530,7 +530,7 @@ subroutine precon_gmres(vv, z, nelemd, xstate, c_ptr_to_object, c_ptr_to_pre) &
use ,intrinsic :: iso_c_binding
use kinds, only : real_kind
use dimensions_mod, only : np, nlev, nvar, nelem
use physical_constants, only : g
use physical_constants, only : gravit
use element_mod, only : element_t
! use parallel_mod, only : parallel_t
use edge_mod, only : edgevpack, edgevunpack
Expand Down Expand Up @@ -630,7 +630,7 @@ subroutine precon_si(vv, z, nelemd, xstate, c_ptr_to_object, c_ptr_to_pre) &

use ,intrinsic :: iso_c_binding
use kinds, only : real_kind
use physical_constants, only : rearth, g
use physical_constants, only : rearth, gravit
use dimensions_mod, only : np, nlev, nvar, nelem
use element_mod, only : element_t
use edge_mod, only : edgevpack, edgevunpack
Expand Down Expand Up @@ -920,7 +920,7 @@ subroutine sw_picard_schur_op(xs, nelemd,fx, c_ptr_to_object) bind(C,name='sw_pi
use bndry_mod, only : bndry_exchangev
use derived_type_mod, only : derived_type
use perf_mod, only : t_startf, t_stopf
use physical_constants, only : g
use physical_constants, only : gravit

implicit none
real (c_double) ,intent(in) :: xs(nelemd)
Expand Down Expand Up @@ -1227,7 +1227,7 @@ subroutine sw_picard_DFinvBt_op(xs, nelemd,fx,nret, c_ptr_to_object) bind(C,name
use bndry_mod, only : bndry_exchangev
use derived_type_mod, only : derived_type
use perf_mod, only : t_startf, t_stopf
use physical_constants, only : g
use physical_constants, only : gravit

implicit none
real (c_double) ,intent(in) :: xs(nelemd)
Expand Down Expand Up @@ -1405,7 +1405,7 @@ subroutine sw_picard_block_11(xs, nelemd,fx, c_ptr_to_object) bind(C,name='sw_pi
use bndry_mod, only : bndry_exchangev
use derived_type_mod, only : derived_type
use perf_mod, only : t_startf, t_stopf
use physical_constants, only : g
use physical_constants, only : gravit

implicit none
real (c_double) ,intent(in) :: xs(nelemd)
Expand Down Expand Up @@ -1615,7 +1615,7 @@ subroutine sw_picard_block_21(xs, nelemd,fx, nret, c_ptr_to_object) bind(C,name=
use bndry_mod, only : bndry_exchangev
use derived_type_mod, only : derived_type
use perf_mod, only : t_startf, t_stopf
use physical_constants, only : g
use physical_constants, only : gravit

implicit none
real (c_double) ,intent(in) :: xs(nelemd)
Expand Down Expand Up @@ -1789,7 +1789,7 @@ subroutine sw_jacobian_op(xs, nelemd,fx, c_ptr_to_object) bind(C,name='sw_jacobi
use bndry_mod, only : bndry_exchangev
use derived_type_mod, only : derived_type
use perf_mod, only : t_startf, t_stopf
use physical_constants, only : g
use physical_constants, only : gravit

implicit none
real (c_double) ,intent(in) :: xs(nelemd)
Expand Down
2 changes: 1 addition & 1 deletion components/homme/src/interp_movie_mod.F90
Original file line number Diff line number Diff line change
Expand Up @@ -30,7 +30,7 @@ module interp_movie_mod
nf_init_decomp, &
get_varindex

use physical_constants, only : omega, g, rrearth, dd_pi, kappa, p0
use physical_constants, only : omega, gravit, rrearth, dd_pi, kappa, p0

use control_mod, only : test_case, runtype, &
restartfreq, &
Expand Down
2 changes: 1 addition & 1 deletion components/homme/src/prim_movie_mod.F90
Original file line number Diff line number Diff line change
Expand Up @@ -50,7 +50,7 @@ module prim_movie_mod
nf_get_frame

use coordinate_systems_mod, only : cartesian2D_t, spherical_polar_t, cartesian3D_t, spherical_to_cart
use physical_constants, only : g, kappa, p0, dd_pi
use physical_constants, only : gravit, kappa, p0, dd_pi
use dof_mod, only : UniquePoints, UniqueCoords, UniqueNcolsP, createmetadata
#ifndef HOMME_WITHOUT_PIOLIBRARY
use pio, only : io_desc_t, pio_iotask_rank !_EXTERNAL
Expand Down
2 changes: 2 additions & 0 deletions components/homme/src/share/control_mod.F90
Original file line number Diff line number Diff line change
Expand Up @@ -219,6 +219,8 @@ module control_mod
real (kind=real_kind), public :: pertlim = 0 !pertibation to temperature [like CESM]
#endif

logical, public :: atm_is_deep = .true. ! height of mountain range (meters)
logical, public :: gravity_is_const = .false. ! height of mountain range (meters)
! shallow water advection test paramters
! kmass = level index with density. other levels contain test tracers
integer, public :: kmass = -1
Expand Down
6 changes: 5 additions & 1 deletion components/homme/src/share/cube_mod.F90
Original file line number Diff line number Diff line change
Expand Up @@ -774,6 +774,7 @@ end subroutine dmap_elementlocal
subroutine coriolis_init_atomic(elem)
use element_mod, only : element_t
use physical_constants, only : omega
use control_mod, only: atm_is_deep

type (element_t) :: elem

Expand All @@ -785,7 +786,10 @@ subroutine coriolis_init_atomic(elem)
rangle = rotate_grid*DD_PI/180
do j=1,np
do i=1,np
if ( rotate_grid /= 0) then
if ( rotate_grid /= 0 ) then
if (atm_is_deep) then
Copy link
Owner Author

Choose a reason for hiding this comment

The reason will be displayed to describe this comment to others. Learn more.

use this abort in OG branch

call abortmp('Rotated grid not yet supported in deep atmosphere')
end if
lat = elem%spherep(i,j)%lat
lon = elem%spherep(i,j)%lon
elem%fcor(i,j)= 2*omega* &
Copy link
Owner Author

Choose a reason for hiding this comment

The reason will be displayed to describe this comment to others. Learn more.

where is cosine part?

Expand Down
Loading