A Scipy-FenicsX interface for incompressible Navier-Stokes
Project description
dolfin_navier_scipy
This python module dns
provides an interface between the FEM toolbox FEniCS
and SciPy
in view of simulation and control of incompressible flows. Basically, FEniCS
is used to discretize the incompressible Navier-Stokes equations in space. Then dns
makes the discretized operators available in SciPy
for use in model reduction, simulation, or control and optimization.
dns
also contains a solver for the steady state and time dependent problems.
Quick Start
To get started, create the needed subdirectories and run one of the tests/time_dep_nse_.py
files, e.g.
pip install sadptprj_riclyap_adi
cd tests
mkdir data
mkdir results
# export PYTHONPATH="$PYTHONPATH:path/to/repo/" # add the repo to the path
# pip install dolfinx_navier_scipy # or install the module using pip
python3 time_dep_nse_expnonl.py
Then, to examine the results, launch
paraview results/vel_TH__timestep.pvd
Test Cases and Examples
A selection:
tests/mini_setup.py
: a minimal setup for a steady-state simulationtests/steadystate_schaefer-turek_2D-1.py
: the 2D steady-state cylinder wake benchmark by Schäfer/Turektests/steadystate_rotcyl.py
: the 2D cylinder wake with a freely rotating cylinder as benchmarked in Richter et al.tests/time_dep_nse_.py
: time integration with Picard and Newton linearizationtests/time_dep_nse_expnonl.py
: time integration with explicit treatment of the nonlinearitytests/time_dep_nse_bcrob.py
: time integration of the cylinder wake with boundary controlstests/time_dep_nse_krylov.py
: time integration with iterative solves of the state equations viakrypy
tests/time_dep_nse_double_rotcyl_bcrob.py
: rotating double cylinder via Robin boundary conditions
Dependencies
- dolfin interface to FEniCS -- tested with
v2019.2.0
,v2018.1.0
,v2017.2
- sadptprj_riclyap_adi
The latter is my home-brew module that includes the submodule lin_alg_utils
with routines for solving the saddle point problem as it arises in the (v,p)
formulation of the NSE.
Documentation
The (old) documentation of the code goes here.
Installation as Module
pip install dolfinx_navier_scipy
Project details
Release history Release notifications | RSS feed
Download files
Download the file for your platform. If you're not sure which to choose, learn more about installing packages.