CliMA/Oceananigans.jl-v0.52.1.zip
CliMA-Oceananigans.jl-5c1ed98
.buildkite
pipeline.yml
11.0 kB
validation-pipeline.yml
12.3 kB
.github
workflows
CompatHelper.yml
466 Bytes
TagBot.yml
317 Bytes
.gitignore
476 Bytes
CONTRIBUTING.md
1.8 kB
Dockerfile
266 Bytes
LICENSE
1.1 kB
Manifest.toml
12.7 kB
Project.toml
2.0 kB
README.md
11.5 kB
benchmark
.gitignore
144 Bytes
Manifest.toml
12.2 kB
Project.toml
556 Bytes
README.md
1.4 kB
benchmark_advection_schemes.jl
1.5 kB
benchmark_equations_of_state.jl
1.6 kB
benchmark_fft_based_poisson_solvers.jl
1.5 kB
benchmark_fourier_tridiagonal_poisson_solver.jl
1.6 kB
benchmark_incompressible_model.jl
1.1 kB
benchmark_lagrangian_particle_tracking.jl
1.8 kB
benchmark_multithreading.jl
835 Bytes
benchmark_multithreading_single.jl
408 Bytes
benchmark_regression.jl
310 Bytes
benchmark_time_steppers.jl
1.5 kB
benchmark_topologies.jl
1.4 kB
benchmark_tracers.jl
2.2 kB
benchmark_transforms.jl
1.9 kB
benchmark_turbulence_closures.jl
1.6 kB
benchmark_vertically_stretched_incompressible_model.jl
1.3 kB
benchmarkable_incompressible_model.jl
680 Bytes
src
Benchmarks.jl
4.2 kB
codecov.yml
207 Bytes
docs
Manifest.toml
29.2 kB
Project.toml
445 Bytes
make.jl
5.7 kB
make_example.jl
2.5 kB
oceananigans.bib
25.0 kB
src
appendix
fractional_step.md
2.7 kB
staggered_grid.md
4.9 kB
benchmarks.md
16.6 kB
contributing.md
5.8 kB
function_index.md
27 Bytes
gallery.md
4.6 kB
index.md
1.4 kB
installation_instructions.md
1.2 kB
library.md
6.7 kB
model_setup
architecture.md
580 Bytes
background_fields.md
3.6 kB
boundary_conditions.md
13.9 kB
buoyancy_and_equation_of_state.md
6.3 kB
checkpointing.md
2.2 kB
clock.md
1.2 kB
coriolis.md
3.9 kB
diagnostics.md
905 Bytes
forcing_functions.md
10.2 kB
grids.md
3.1 kB
lagrangian_particles.md
3.7 kB
number_type.md
1.1 kB
output_writers.md
11.9 kB
overview.md
628 Bytes
setting_initial_conditions.md
1.1 kB
tracers.md
2.8 kB
turbulent_diffusivity_closures_and_les_models.md
2.5 kB
numerical_implementation
assets
staggered_grid.png
126.7 kB
boundary_conditions.md
5.6 kB
finite_volume.md
2.0 kB
large_eddy_simulation.md
7.8 kB
poisson_solvers.md
10.2 kB
pressure_decomposition.md
1.6 kB
spatial_operators.md
8.1 kB
time_stepping.md
3.9 kB
turbulence_closures.md
4.9 kB
physics
boundary_conditions.md
1.3 kB
buoyancy_and_equations_of_state.md
1.5 kB
coriolis_forces.md
2.8 kB
navier_stokes_and_tracer_conservation.md
6.7 kB
surface_gravity_waves.md
2.9 kB
turbulence_closures.md
8.0 kB
references.md
35 Bytes
using_gpus.md
3.4 kB
validation
convergence_tests.md
9.7 kB
lid_driven_cavity.md
3.7 kB
stratified_couette_flow.md
3.1 kB
examples
convecting_plankton.jl
11.9 kB
eady_turbulence.jl
15.2 kB
geostrophic_adjustment.jl
4.3 kB
internal_wave.jl
6.4 kB
kelvin_helmholtz_instability.jl
17.8 kB
langmuir_turbulence.jl
13.6 kB
ocean_wind_mixing_and_convection.jl
10.3 kB
one_dimensional_diffusion.jl
4.9 kB
spherical_splash.jl
5.1 kB
two_dimensional_turbulence.jl
4.6 kB
paper
free_convection_and_baroclinic_instability.png
1.4 MB
paper.bib
4.1 kB
paper.md
5.4 kB
src
AbstractOperations
AbstractOperations.jl
1.9 kB
at.jl
965 Bytes
averages_of_operations.jl
1.3 kB
binary_operations.jl
6.6 kB
derivatives.jl
3.8 kB
grid_validation.jl
1.2 kB
multiary_operations.jl
5.9 kB
show_abstract_operations.jl
3.2 kB
unary_operations.jl
4.1 kB
Advection
Advection.jl
1.3 kB
centered_advective_fluxes.jl
3.0 kB
centered_fourth_order.jl
1.6 kB
centered_second_order.jl
2.0 kB
momentum_advection_operators.jl
2.5 kB
topologically_conditional_interpolation.jl
2.3 kB
tracer_advection_operators.jl
900 Bytes
upwind_biased_advective_fluxes.jl
5.1 kB
upwind_biased_fifth_order.jl
3.0 kB
upwind_biased_third_order.jl
2.5 kB
weno_fifth_order.jl
13.2 kB
Architectures.jl
1.3 kB
BoundaryConditions
BoundaryConditions.jl
1.3 kB
apply_flux_bcs.jl
6.0 kB
boundary_condition.jl
4.2 kB
boundary_condition_types.jl
2.4 kB
continuous_boundary_function.jl
6.0 kB
coordinate_boundary_conditions.jl
388 Bytes
discrete_boundary_function.jl
1.6 kB
field_boundary_conditions.jl
12.2 kB
fill_halo_regions.jl
2.1 kB
fill_halo_regions_flux.jl
2.4 kB
fill_halo_regions_normal_flow.jl
1.9 kB
fill_halo_regions_nothing.jl
500 Bytes
fill_halo_regions_periodic.jl
1.1 kB
fill_halo_regions_value_gradient.jl
5.4 kB
show_boundary_conditions.jl
1.6 kB
Buoyancy
Buoyancy.jl
2.6 kB
buoyancy_field.jl
4.4 kB
linear_equation_of_state.jl
2.6 kB
nonlinear_equation_of_state.jl
3.1 kB
seawater_buoyancy.jl
6.8 kB
Coriolis
Coriolis.jl
813 Bytes
beta_plane.jl
2.0 kB
f_plane.jl
1.7 kB
hydrostatic_spherical_coriolis.jl
3.2 kB
no_rotation.jl
314 Bytes
non_traditional_beta_plane.jl
3.5 kB
non_traditional_f_plane.jl
2.6 kB
Diagnostics
Diagnostics.jl
425 Bytes
cfl.jl
1.7 kB
field_slicer.jl
3.6 kB
nan_checker.jl
685 Bytes
windowed_spatial_average.jl
1.6 kB
Fields
Fields.jl
1.2 kB
abstract_field.jl
7.6 kB
averaged_field.jl
3.1 kB
background_fields.jl
2.3 kB
computed_field.jl
4.8 kB
field.jl
5.3 kB
field_tuples.jl
5.7 kB
function_field.jl
3.9 kB
interpolate.jl
3.7 kB
kernel_computed_field.jl
5.2 kB
new_data.jl
2.6 kB
pressure_field.jl
256 Bytes
reduced_field.jl
5.0 kB
set!.jl
3.2 kB
show_fields.jl
2.0 kB
tracer_names.jl
560 Bytes
validate_field_tuple_grid.jl
744 Bytes
zero_field.jl
132 Bytes
Forcings
Forcings.jl
280 Bytes
continuous_forcing.jl
5.8 kB
discrete_forcing.jl
1.9 kB
forcing.jl
5.5 kB
model_forcing.jl
1.9 kB
relaxation.jl
5.4 kB
Grids
Grids.jl
2.7 kB
grid_utils.jl
10.2 kB
input_validation.jl
4.5 kB
regular_latitude_longitude_grid.jl
4.8 kB
regular_rectilinear_grid.jl
9.5 kB
vertically_stretched_rectilinear_grid.jl
8.7 kB
LagrangianParticleTracking
LagrangianParticleTracking.jl
3.8 kB
update_particle_properties.jl
4.0 kB
Logger.jl
2.9 kB
Models
HydrostaticFreeSurfaceModels
HydrostaticFreeSurfaceModels.jl
1.8 kB
barotropic_pressure_correction.jl
1.3 kB
calculate_hydrostatic_free_surface_tendencies.jl
7.6 kB
compute_w_from_continuity.jl
1.1 kB
explicit_free_surface.jl
1.2 kB
hydrostatic_free_surface_ab2_step.jl
2.4 kB
hydrostatic_free_surface_advection.jl
2.4 kB
hydrostatic_free_surface_model.jl
9.3 kB
hydrostatic_free_surface_tendency_fields.jl
740 Bytes
hydrostatic_free_surface_tendency_kernel_functions.jl
8.1 kB
hydrostatic_free_surface_velocity_fields.jl
963 Bytes
implicit_free_surface.jl
31 Bytes
rigid_lid.jl
258 Bytes
set_hydrostatic_free_surface_model.jl
1.6 kB
show_hydrostatic_free_surface_model.jl
1.0 kB
update_hydrostatic_free_surface_model_state.jl
1.6 kB
IncompressibleModels
IncompressibleModels.jl
950 Bytes
calculate_tendencies.jl
10.2 kB
correct_incompressible_immersed_tendencies.jl
2.9 kB
incompressible_model.jl
9.1 kB
non_dimensional_model.jl
1.3 kB
pressure_correction.jl
1.7 kB
set_incompressible_model.jl
1.7 kB
show_incompressible_model.jl
1.0 kB
update_hydrostatic_pressure.jl
723 Bytes
update_incompressible_model_state.jl
1.4 kB
velocity_and_tracer_tendencies.jl
10.1 kB
Models.jl
613 Bytes
ShallowWaterModels
ShallowWaterModels.jl
1.1 kB
calculate_shallow_water_tendencies.jl
9.1 kB
rk3_substep_shallow_water_model.jl
2.2 kB
set_shallow_water_model.jl
591 Bytes
shallow_water_advection_operators.jl
2.1 kB
shallow_water_cell_advection_timescale.jl
621 Bytes
shallow_water_model.jl
5.6 kB
show_shallow_water_model.jl
520 Bytes
solution_and_tracer_tendencies.jl
3.1 kB
store_shallow_water_tendencies.jl
1.7 kB
update_shallow_water_state.jl
518 Bytes
Oceananigans.jl
5.3 kB
Operators
Operators.jl
2.7 kB
README
1.7 kB
areas_and_volumes.jl
6.3 kB
derivative_operators.jl
5.6 kB
difference_operators.jl
3.7 kB
divergence_operators.jl
1.3 kB
field_metric_products.jl
1.2 kB
interpolation_operators.jl
6.2 kB
interpolation_utils.jl
3.2 kB
laplacian_operators.jl
2.2 kB
vorticity_operators.jl
392 Bytes
OutputWriters
OutputWriters.jl
875 Bytes
checkpointer.jl
13.1 kB
fetch_output.jl
1.3 kB
jld2_output_writer.jl
10.7 kB
netcdf_output_writer.jl
20.7 kB
output_writer_utils.jl
5.5 kB
time_average_outputs.jl
1.2 kB
windowed_time_average.jl
8.5 kB
Simulations
Simulations.jl
489 Bytes
run.jl
6.8 kB
simulation.jl
4.4 kB
time_step_wizard.jl
1.8 kB
Solvers
Solvers.jl
1.4 kB
batched_tridiagonal_solver.jl
4.0 kB
discrete_transforms.jl
5.1 kB
fft_based_poisson_solver.jl
2.5 kB
fourier_tridiagonal_poisson_solver.jl
3.2 kB
index_permutations.jl
2.8 kB
plan_transforms.jl
14.5 kB
poisson_eigenvalues.jl
1.0 kB
preconditioned_conjugate_gradient_solver.jl
6.2 kB
solve_for_pressure.jl
2.1 kB
StokesDrift.jl
2.7 kB
TimeSteppers
TimeSteppers.jl
1.3 kB
clock.jl
2.5 kB
correct_immersed_tendencies.jl
282 Bytes
quasi_adams_bashforth_2.jl
3.2 kB
runge_kutta_3.jl
4.9 kB
store_tendencies.jl
1.1 kB
TurbulenceClosures
TurbulenceClosures.jl
5.9 kB
closure_tuples.jl
1.3 kB
diffusion_operators.jl
3.4 kB
diffusivity_fields.jl
3.0 kB
turbulence_closure_diagnostics.jl
5.0 kB
turbulence_closure_implementations
anisotropic_biharmonic_diffusivity.jl
3.5 kB
anisotropic_diffusivity.jl
3.6 kB
blasius_smagorinsky.jl
4.8 kB
horizontally_curvilinear_anistropic_diffusivity.jl
3.2 kB
isotropic_diffusivity.jl
2.6 kB
leith_enstrophy_diffusivity.jl
8.8 kB
nothing_closure.jl
530 Bytes
rozema_anisotropic_minimum_dissipation.jl
7.7 kB
smagorinsky_lilly.jl
9.4 kB
verstappen_anisotropic_minimum_dissipation.jl
15.3 kB
turbulence_closure_utils.jl
1.1 kB
velocity_tracer_gradients.jl
9.6 kB
viscous_dissipation_operators.jl
10.2 kB
Units.jl
3.0 kB
Utils
Utils.jl
975 Bytes
automatic_halo_sizing.jl
606 Bytes
cell_advection_timescale.jl
581 Bytes
kernel_launching.jl
3.2 kB
ordered_dict_show.jl
658 Bytes
output_writer_diagnostic_utils.jl
949 Bytes
pretty_filesize.jl
708 Bytes
pretty_time.jl
1.6 kB
schedules.jl
3.3 kB
tuple_utils.jl
574 Bytes
user_function_arguments.jl
1.6 kB
versioninfo.jl
1.1 kB
with_tracers.jl
1.3 kB
test
regression_tests
data
ocean_large_eddy_simulation_SmagorinskyLilly_iteration10000.jld2
736.2 kB
ocean_large_eddy_simulation_SmagorinskyLilly_iteration10010.jld2
736.2 kB
ocean_large_eddy_simulation_VerstappenAnisotropicMinimumDissipation_iteration10000.jld2
736.2 kB
ocean_large_eddy_simulation_VerstappenAnisotropicMinimumDissipation_iteration10010.jld2
736.2 kB
rayleigh_benard_iteration1000.jld2
729.8 kB
rayleigh_benard_iteration1100.jld2
729.8 kB
thermal_bubble_regression.nc
372.9 kB
ocean_large_eddy_simulation_regression_test.jl
5.3 kB
rayleigh_benard_regression_test.jl
5.9 kB
thermal_bubble_regression_test.jl
2.7 kB
runtests.jl
4.1 kB
test_abstract_operations_computed_field.jl
25.7 kB
test_averaged_field.jl
3.0 kB
test_boundary_conditions.jl
9.8 kB
test_boundary_conditions_integration.jl
11.3 kB
test_buoyancy.jl
4.2 kB
test_convergence.jl
2.5 kB
test_coriolis.jl
6.1 kB
test_diagnostics.jl
3.6 kB
test_dynamics.jl
13.2 kB
test_field.jl
9.6 kB
test_forcings.jl
5.9 kB
test_grids.jl
22.5 kB
test_halo_regions.jl
2.3 kB
test_hydrostatic_free_surface_models.jl
5.0 kB
test_incompressible_models.jl
7.5 kB
test_kernel_computed_field.jl
2.6 kB
test_lagrangian_particle_tracking.jl
6.3 kB
test_operators.jl
7.4 kB
test_output_writers.jl
46.4 kB
test_poisson_solvers.jl
10.1 kB
test_preconditioned_conjugate_gradient_solver.jl
2.7 kB
test_reduced_field.jl
4.2 kB
test_regression.jl
3.5 kB
test_shallow_water_models.jl
6.2 kB
test_simulations.jl
4.2 kB
test_solvers.jl
4.2 kB
test_stokes_drift.jl
524 Bytes
test_time_stepping.jl
13.0 kB
test_turbulence_closures.jl
8.7 kB
test_utils.jl
1.1 kB
test_validation.jl
846 Bytes
utils_for_runtests.jl
4.8 kB
validation
bickley_jet
bickley_jet.jl
6.4 kB
disk_time_series.jl
1.6 kB
convergence_tests
Manifest.toml
9.3 kB
Project.toml
587 Bytes
README.md
1.8 kB
analyze_forced_fixed_slip.jl
2.7 kB
analyze_forced_free_slip.jl
2.3 kB
analyze_taylor_green.jl
1.8 kB
derive_forced_fixed_slip.nb
60.3 kB
one_dimensional_advection_schemes.jl
7.7 kB
one_dimensional_cosine_advection_diffusion.jl
4.5 kB
one_dimensional_gaussian_advection_diffusion.jl
4.8 kB
point_exponential_decay.jl
2.4 kB
run_forced_fixed_slip.jl
611 Bytes
run_forced_free_slip.jl
518 Bytes
run_taylor_green.jl
443 Bytes
src
ConvergenceTests.jl
1.7 kB
DoublyPeriodicTaylorGreen.jl
2.2 kB
ForcedFlowFixedSlip.jl
5.6 kB
ForcedFlowFreeSlip.jl
4.4 kB
OneDimensionalCosineAdvectionDiffusion.jl
7.2 kB
OneDimensionalGaussianAdvectionDiffusion.jl
7.4 kB
OneDimensionalUtils.jl
5.0 kB
PointExponentialDecay.jl
1.6 kB
TwoDimensionalDiffusion.jl
2.3 kB
analysis.jl
2.6 kB
file_wrangling.jl
873 Bytes
two_dimensional_diffusion.jl
2.7 kB
immersed_boundaries
flow_around_cylinder.jl
4.0 kB
lid_driven_cavity
lid_driven_cavity.jl
3.4 kB
plot_lid_driven_cavity.py
8.5 kB
periodic_advection
periodic_advection.jl
3.6 kB
solid_body_rotation
hydrostatic_prescribed_velocity_fields.jl
2.0 kB
solid_body_rotation.jl
9.9 kB
solid_body_tracer_advection.jl
6.8 kB
stommel_gyre
plot_stommel_gyre_advection.py
1.7 kB
stommel_gyre.jl
827 Bytes
stommel_gyre_advection.jl
3.9 kB
stratified_couette_flow
run_stratified_couette_flow_simulations.jl
214 Bytes
stratified_couette_flow.jl
9.8 kB
stratified_couette_flow_analysis.jl
8.8 kB
thermal_bubble
plot_thermal_bubble_advection.py
2.1 kB
thermal_bubble.jl
2.6 kB