MADNESS
version 0.9
|
Example Solving the Navier-Stokes equations. More...
Macros | |
#define | myfun std::vector< Function<T,NDIM> > |
Typedefs | |
typedef Vector< double, 3 > | coordT3d |
typedef Vector< double, 3 > | coordT |
typedef Vector< double, 1 > | coordT1d |
typedef Function< double, 3 > | functionT |
typedef std::vector< functionT > | functT |
Functions | |
functionT | div (const functT &uint) |
functionT | lap (const functionT &uint) |
template<typename T , int NDIM> | |
void | adv (const myfun &uu, myfun &advu) |
template<typename T , int NDIM> | |
myfun | operator- (const myfun &l, const myfun &r) |
void | testNavierStokes (int argc, char **argv) |
int | main (int argc, char **argv) |
Variables | |
const double | pi =madness::constants::pi |
const double | L = 2*pi |
const double | N = 8.0 |
const double | mu = 1 |
const double | deltaT = pi*0.0001 |
const int | Nts = L/deltaT+10 |
const int | k = 10 |
const double | pthresh = 1.e-9 |
const double | pthresh1 = 1e-10 |
const double | uthresh = pthresh |
const double | uthresh1 = pthresh1 |
double | mytime = 0.0 |
const double | cc = 0 |
World * | pworld |
Example Solving the Navier-Stokes equations.
Referenced by testNavierStokes().
Referenced by testNavierStokes().
Referenced by testNavierStokes().
int main | ( | int | argc, |
char ** | argv | ||
) |
References testNavierStokes().
References madness::sub().
void testNavierStokes | ( | int | argc, |
char ** | argv | ||
) |
References a(), adv(), madness::apply(), b(), madness::BC_PERIODIC, c, SafeMPI::COMM_WORLD, deltaT, div(), madness::error(), madness::f, madness::finalize(), madness::gaxpy(), madness::FunctionDefaults< NDIM >::get_cell_width(), madness::initialize(), k, L, lap(), madness::Function< T, NDIM >::max_depth(), mu, mytime, madness::Function< T, NDIM >::norm2(), Nts, op(), pi, madness::plotvtk_begin(), madness::plotvtk_data(), madness::print(), pthresh, pthresh1, madness::scale(), madness::Function< T, NDIM >::scale(), madness::FunctionDefaults< NDIM >::set_bc(), madness::FunctionDefaults< NDIM >::set_cubic_cell(), madness::FunctionDefaults< NDIM >::set_k(), madness::FunctionDefaults< NDIM >::set_thresh(), sqrt(), madness::startup(), and uthresh1.
Referenced by main().
const double cc = 0 |
const double deltaT = pi*0.0001 |
Referenced by testNavierStokes().
const int k = 10 |
Referenced by testNavierStokes().
const double L = 2*pi |
Referenced by testNavierStokes().
const double mu = 1 |
Referenced by madness::FunctionCommonData< T, NDIM >::_init_quadrature(), madness::SCF::dipole(), madness::TwoElectronInterface< double, 6 >::initialize(), madness::TwoElectronInterface< double, 6 >::make_coeff(), makedata(), nuclear_potential(), madness::FunctionImpl< T, NDIM >::phi_for_mul(), SCF::PM_q(), test(), test_gence(), testbsh(), and testNavierStokes().
double mytime = 0.0 |
Referenced by testNavierStokes().
const double N = 8.0 |
Referenced by madness::tr1::array::array< real_tensor, 118 >::back(), madness::FunctionImpl< T, NDIM >::coeffs_for_jun(), madness::tr1::array::array< real_tensor, 118 >::end(), madness::hash_value(), madness::FunctionImpl< T, NDIM >::max_local_depth(), madness::tr1::array::array< real_tensor, 118 >::max_size(), madness::norm(), madness::Vector< int, 3 >::normf(), madness::operator*(), madness::Vector< int, 3 >::operator*=(), madness::operator+(), madness::Vector< int, 3 >::operator+=(), madness::operator-(), madness::Vector< int, 3 >::operator-=(), madness::operator<<(), madness::Vector< int, 3 >::operator=(), CFFT::Perform(), projectPsi(), madness::Stack< T, N >::push(), CFFT::Rearrange(), CFFT::Scale(), madness::tr1::array::array< real_tensor, 118 >::size(), madness::SpectralPropagator::step(), and madness::SpectralPropagatorGaussLobatto::step().
Referenced by testNavierStokes().
const double pi =madness::constants::pi |
Referenced by madness::HartreeFock< T, NDIM >::calculate_tot_coulomb_energy(), madness::HartreeFock< T, NDIM >::calculate_tot_exchange_energy(), madness::HartreeFock< T, NDIM >::calculate_tot_ke_sp(), madness::DFT< T, NDIM >::calculate_tot_ke_sp(), madness::HartreeFock< T, NDIM >::calculate_tot_pe_sp(), DFTSolventSolver::dESP_drho(), madness::detail::adqtest::exact(), madness::gauss_legendre_numeric(), madness::DistributedMatrix< double >::get_colrange(), madness::DistributedMatrixDistribution::get_range(), DFTSolventSolver::Laplace_ESP(), main(), DFTSolventSolver::make_electric_field(), DFTSolventSolver::make_surfcharge(), madness::EigSolverOp< T, NDIM >::multi_op_o(), madness::EigSolverOp< T, NDIM >::multi_op_r(), madness::EigSolver< T, NDIM >::multi_solve(), TimeIncident::operator()(), CFFT::Perform(), FrequencyHandler::read_file(), EnvelopedPulse::read_param_file(), ScreenSolventPotential::ScreenSolventPotential(), madness::SeparatedConvolution< T, NDIM >::SeparatedConvolution(), madness::EigSolver< T, NDIM >::solve(), test(), and testNavierStokes().
const double pthresh = 1.e-9 |
Referenced by testNavierStokes().
const double pthresh1 = 1e-10 |
Referenced by testNavierStokes().
World* pworld |
const double uthresh = pthresh |
const double uthresh1 = pthresh1 |
Referenced by testNavierStokes().