IBAMR
An adaptive and distributed-memory parallel implementation of the immersed boundary (IB) method
|
This is the complete list of members for IBAMR::IBMethod, including all inherited members.
AB2Step(double current_time, double new_time) | IBAMR::IBStrategy | virtual |
activateLagrangianStructure(int structure_number=0, int level_number=std::numeric_limits< int >::max()) override | IBAMR::IBMethod | virtual |
addWorkloadEstimate(SAMRAI::tbox::Pointer< SAMRAI::hier::PatchHierarchy< NDIM > > hierarchy, const int workload_data_idx) override | IBAMR::IBMethod | virtual |
advanceLevel(const tbox::Pointer< hier::BasePatchLevel< NDIM > > level, const tbox::Pointer< hier::BasePatchHierarchy< NDIM > > hierarchy, const double current_time, const double new_time, const bool first_step, const bool last_step, const bool regrid_advance=false) | SAMRAI::mesh::StandardTagAndInitStrategy< NDIM > | virtual |
applyGradientDetector(SAMRAI::tbox::Pointer< SAMRAI::hier::BasePatchHierarchy< NDIM > > hierarchy, int level_number, double error_data_time, int tag_index, bool initial_time, bool uses_richardson_extrapolation_too) override | IBAMR::IBMethod | virtual |
applyRichardsonExtrapolation(const tbox::Pointer< hier::PatchLevel< NDIM > > level, const double error_data_time, const int tag_index, const double deltat, const int error_coarsen_ratio, const bool initial_time, const bool uses_gradient_detector_too) | SAMRAI::mesh::StandardTagAndInitStrategy< NDIM > | virtual |
backwardEulerStep(double current_time, double new_time) override | IBAMR::IBMethod | virtual |
beginDataRedistribution(SAMRAI::tbox::Pointer< SAMRAI::hier::PatchHierarchy< NDIM > > hierarchy, SAMRAI::tbox::Pointer< SAMRAI::mesh::GriddingAlgorithm< NDIM > > gridding_alg) override | IBAMR::IBMethod | virtual |
coarsenDataForRichardsonExtrapolation(const tbox::Pointer< hier::PatchHierarchy< NDIM > > hierarchy, const int level_number, const tbox::Pointer< hier::PatchLevel< NDIM > > coarser_level, const double coarsen_data_time, const bool before_advance) | SAMRAI::mesh::StandardTagAndInitStrategy< NDIM > | virtual |
computeForce(Vec X, Vec F) (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
computeForce_SAMRAI(void *ctx, Vec X, Vec F) (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protectedstatic |
computeLagrangianFluidSource(double data_time) override | IBAMR::IBMethod | virtual |
computeLagrangianForce(double data_time) override | IBAMR::IBMethod | virtual |
computeLinearizedLagrangianForce(Vec &X_vec, double data_time) override | IBAMR::IBMethod | virtual |
computeLinearizedResidual(Vec &X_vec, Vec &R_vec) override | IBAMR::IBMethod | virtual |
computeResidual(Vec &R_vec) override | IBAMR::IBMethod | virtual |
constructInterpOp(Mat &J, void(*spread_fnc)(const double, double *), int stencil_width, const std::vector< int > &num_dofs_per_proc, int dof_index_idx, double data_time) override | IBAMR::IBMethod | virtual |
constructLagrangianForceJacobian(Mat &A, MatType mat_type, double data_time) override | IBAMR::IBMethod | virtual |
createSolverVecs(Vec *X_vec, Vec *F_vec) override | IBAMR::IBMethod | virtual |
d_anchor_point_local_idxs (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_current_time (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_do_log (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_error_if_points_leave_domain (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_F_current_data (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_F_current_needs_ghost_fill (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_F_half_data (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_F_half_needs_ghost_fill (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_F_jac_data (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_F_jac_needs_ghost_fill (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_F_new_data (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_F_new_needs_ghost_fill (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_ghosts (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_gridding_alg (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_half_time (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_hierarchy (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_ib_force_fcn (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_ib_force_fcn_needs_init (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_ib_solver | IBAMR::IBStrategy | protected |
d_ib_source_fcn (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_ib_source_fcn_needs_init (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_instrument_panel (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_interp_kernel_fcn (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_l_data_manager (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_l_initializer (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_load_balancer (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_n_src (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_new_time (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_normalize_source_strength (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_object_name (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_P_src (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_post_processor (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_Q_src (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_r_src (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_registered_for_restart (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_silo_writer (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_spread_kernel_fcn (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_total_flow_volume (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_U_current_data (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_U_half_data (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_U_jac_data (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_U_new_data (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_use_fixed_coupling_ops | IBAMR::IBStrategy | protected |
d_workload_idx (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_X_current_data (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_X_current_needs_ghost_fill (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_X_half_data (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_X_half_needs_ghost_fill (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_X_jac_data (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_X_jac_needs_ghost_fill (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_X_LE_half_data (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_X_LE_half_needs_ghost_fill (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_X_LE_new_data (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_X_LE_new_needs_ghost_fill (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_X_new_data (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_X_new_needs_ghost_fill (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
d_X_src (defined in IBAMR::IBMethod) | IBAMR::IBMethod | protected |
endDataRedistribution(SAMRAI::tbox::Pointer< SAMRAI::hier::PatchHierarchy< NDIM > > hierarchy, SAMRAI::tbox::Pointer< SAMRAI::mesh::GriddingAlgorithm< NDIM > > gridding_alg) override | IBAMR::IBMethod | virtual |
forwardEulerStep(double current_time, double new_time) override | IBAMR::IBMethod | virtual |
freeLInitStrategy() | IBAMR::IBMethod | |
getCoarsenAlgorithm(const std::string &name) const | IBAMR::IBStrategy | protected |
getCoarsenSchedules(const std::string &name) const | IBAMR::IBStrategy | protected |
getForceData(std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > **F_data, bool **F_needs_ghost_fill, double data_time) | IBAMR::IBMethod | protected |
getGhostfillRefineAlgorithm(const std::string &name) const | IBAMR::IBStrategy | protected |
getGhostfillRefineSchedules(const std::string &name) const | IBAMR::IBStrategy | protected |
getHierarchyMathOps() const | IBAMR::IBStrategy | protected |
getIBInstrumentPanel() const | IBAMR::IBMethod | |
getINSHierarchyIntegrator() const | IBAMR::IBStrategy | protected |
getLagrangianStructureIsActivated(int structure_number=0, int level_number=std::numeric_limits< int >::max()) const override | IBAMR::IBMethod | virtual |
getLDataManager() const | IBAMR::IBMethod | |
getLECouplingPositionData(std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > **X_LE_data, bool **X_LE_needs_ghost_fill, double data_time) | IBAMR::IBMethod | protected |
getLevelDt(const tbox::Pointer< hier::BasePatchLevel< NDIM > > level, const double dt_time, const bool initial_time) | SAMRAI::mesh::StandardTagAndInitStrategy< NDIM > | virtual |
getLinearizedForceData(std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > **F_data, bool **F_needs_ghost_fill) | IBAMR::IBMethod | protected |
getLinearizedPositionData(std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > **X_data, bool **X_needs_ghost_fill) | IBAMR::IBMethod | protected |
getLinearizedVelocityData(std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > **U_data) | IBAMR::IBMethod | protected |
getMaxPointDisplacement() const | IBAMR::IBStrategy | virtual |
getMinimumGhostCellWidth() const override | IBAMR::IBMethod | virtual |
getPositionData(std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > **X_data, bool **X_needs_ghost_fill, double data_time) | IBAMR::IBMethod | protected |
getPressureHierarchyDataOps() const | IBAMR::IBStrategy | protected |
getProlongRefineAlgorithm(const std::string &name) const | IBAMR::IBStrategy | protected |
getProlongRefineSchedules(const std::string &name) const | IBAMR::IBStrategy | protected |
getVelocityData(std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > **U_data, double data_time) | IBAMR::IBMethod | protected |
getVelocityHierarchyDataOps() const | IBAMR::IBStrategy | protected |
hasFluidSources() const override | IBAMR::IBMethod | virtual |
IBImplicitStrategy()=default | IBAMR::IBImplicitStrategy | |
IBMethod(std::string object_name, SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > input_db, bool register_for_restart=true) | IBAMR::IBMethod | |
IBStrategy()=default | IBAMR::IBStrategy | |
inactivateLagrangianStructure(int structure_number=0, int level_number=std::numeric_limits< int >::max()) override | IBAMR::IBMethod | virtual |
initializeLevelData(SAMRAI::tbox::Pointer< SAMRAI::hier::BasePatchHierarchy< NDIM > > hierarchy, int level_number, double init_data_time, bool can_be_refined, bool initial_time, SAMRAI::tbox::Pointer< SAMRAI::hier::BasePatchLevel< NDIM > > old_level, bool allocate_data) override | IBAMR::IBMethod | virtual |
initializePatchHierarchy(SAMRAI::tbox::Pointer< SAMRAI::hier::PatchHierarchy< NDIM > > hierarchy, SAMRAI::tbox::Pointer< SAMRAI::mesh::GriddingAlgorithm< NDIM > > gridding_alg, int u_data_idx, const std::vector< SAMRAI::tbox::Pointer< SAMRAI::xfer::CoarsenSchedule< NDIM > > > &u_synch_scheds, const std::vector< SAMRAI::tbox::Pointer< SAMRAI::xfer::RefineSchedule< NDIM > > > &u_ghost_fill_scheds, int integrator_step, double init_data_time, bool initial_time) override | IBAMR::IBMethod | virtual |
interpolateLinearizedVelocity(int u_data_idx, const std::vector< SAMRAI::tbox::Pointer< SAMRAI::xfer::CoarsenSchedule< NDIM > > > &u_synch_scheds, const std::vector< SAMRAI::tbox::Pointer< SAMRAI::xfer::RefineSchedule< NDIM > > > &u_ghost_fill_scheds, double data_time) override | IBAMR::IBMethod | virtual |
interpolatePressure(int p_data_idx, const std::vector< SAMRAI::tbox::Pointer< SAMRAI::xfer::CoarsenSchedule< NDIM > > > &p_synch_scheds, const std::vector< SAMRAI::tbox::Pointer< SAMRAI::xfer::RefineSchedule< NDIM > > > &p_ghost_fill_scheds, double data_time) override | IBAMR::IBMethod | virtual |
interpolateVelocity(int u_data_idx, const std::vector< SAMRAI::tbox::Pointer< SAMRAI::xfer::CoarsenSchedule< NDIM > > > &u_synch_scheds, const std::vector< SAMRAI::tbox::Pointer< SAMRAI::xfer::RefineSchedule< NDIM > > > &u_ghost_fill_scheds, double data_time) override | IBAMR::IBMethod | virtual |
midpointStep(double current_time, double new_time) override | IBAMR::IBMethod | virtual |
postprocessData() override | IBAMR::IBMethod | virtual |
postprocessIntegrateData(double current_time, double new_time, int num_cycles) override | IBAMR::IBMethod | virtual |
postprocessSolveFluidEquations(double current_time, double new_time, int cycle_num) | IBAMR::IBStrategy | virtual |
preprocessIntegrateData(double current_time, double new_time, int num_cycles) override | IBAMR::IBMethod | virtual |
preprocessSolveFluidEquations(double current_time, double new_time, int cycle_num) | IBAMR::IBStrategy | virtual |
putToDatabase(SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > db) override | IBAMR::IBMethod | virtual |
registerCoarsenAlgorithm(const std::string &name, SAMRAI::tbox::Pointer< SAMRAI::xfer::CoarsenAlgorithm< NDIM > > coarsen_alg, std::unique_ptr< SAMRAI::xfer::CoarsenPatchStrategy< NDIM > > coarsen_patch_strategy=nullptr) | IBAMR::IBStrategy | protected |
registerEulerianCommunicationAlgorithms() | IBAMR::IBStrategy | virtual |
registerEulerianVariables() | IBAMR::IBStrategy | virtual |
registerGhostfillRefineAlgorithm(const std::string &name, SAMRAI::tbox::Pointer< SAMRAI::xfer::RefineAlgorithm< NDIM > > ghostfill_alg, std::unique_ptr< SAMRAI::xfer::RefinePatchStrategy< NDIM > > ghostfill_patch_strategy=nullptr) | IBAMR::IBStrategy | protected |
registerIBHierarchyIntegrator(IBHierarchyIntegrator *ib_solver) | IBAMR::IBStrategy | virtual |
registerIBLagrangianForceFunction(SAMRAI::tbox::Pointer< IBLagrangianForceStrategy > ib_force_fcn) | IBAMR::IBMethod | |
registerIBLagrangianSourceFunction(SAMRAI::tbox::Pointer< IBLagrangianSourceStrategy > ib_source_fcn) | IBAMR::IBMethod | |
registerIBMethodPostProcessor(SAMRAI::tbox::Pointer< IBMethodPostProcessStrategy > post_processor) | IBAMR::IBMethod | |
registerLInitStrategy(SAMRAI::tbox::Pointer< IBTK::LInitStrategy > l_initializer) | IBAMR::IBMethod | |
registerLoadBalancer(SAMRAI::tbox::Pointer< SAMRAI::mesh::LoadBalancer< NDIM > > load_balancer, int workload_data_idx) override | IBAMR::IBMethod | virtual |
registerLSiloDataWriter(SAMRAI::tbox::Pointer< IBTK::LSiloDataWriter > silo_writer) | IBAMR::IBMethod | |
registerProlongRefineAlgorithm(const std::string &name, SAMRAI::tbox::Pointer< SAMRAI::xfer::RefineAlgorithm< NDIM > > prolong_alg, std::unique_ptr< SAMRAI::xfer::RefinePatchStrategy< NDIM > > prolong_patch_strategy=nullptr) | IBAMR::IBStrategy | protected |
registerVariable(int ¤t_idx, int &new_idx, int &scratch_idx, SAMRAI::tbox::Pointer< SAMRAI::hier::Variable< NDIM > > variable, const SAMRAI::hier::IntVector< NDIM > &scratch_ghosts=SAMRAI::hier::IntVector< NDIM >(0), const std::string &coarsen_name="NO_COARSEN", const std::string &refine_name="NO_REFINE", SAMRAI::tbox::Pointer< IBTK::CartGridFunction > init_fcn=nullptr, const bool register_for_restart=true) | IBAMR::IBStrategy | protected |
registerVariable(int &idx, SAMRAI::tbox::Pointer< SAMRAI::hier::Variable< NDIM > > variable, const SAMRAI::hier::IntVector< NDIM > &ghosts=SAMRAI::hier::IntVector< NDIM >(0), SAMRAI::tbox::Pointer< SAMRAI::hier::VariableContext > ctx=SAMRAI::tbox::Pointer< SAMRAI::hier::VariableContext >(nullptr), const bool register_for_restart=true) | IBAMR::IBStrategy | protected |
reinitMidpointData(const std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > ¤t_data, const std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > &new_data, const std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > &half_data) | IBAMR::IBMethod | protected |
resetAnchorPointValues(std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > U_data, int coarsest_ln, int finest_ln) | IBAMR::IBMethod | protected |
resetDataToPreadvanceState(const tbox::Pointer< hier::BasePatchLevel< NDIM > > level) | SAMRAI::mesh::StandardTagAndInitStrategy< NDIM > | virtual |
resetHierarchyConfiguration(SAMRAI::tbox::Pointer< SAMRAI::hier::BasePatchHierarchy< NDIM > > hierarchy, int coarsest_level, int finest_level) override | IBAMR::IBMethod | virtual |
resetTimeDependentData(const tbox::Pointer< hier::BasePatchLevel< NDIM > > level, const double new_time, const bool can_be_refined) | SAMRAI::mesh::StandardTagAndInitStrategy< NDIM > | virtual |
Serializable() | SAMRAI::tbox::Serializable | |
setLinearizedPosition(Vec &X_vec, double data_time) override | IBAMR::IBMethod | virtual |
setUpdatedPosition(Vec &X_new_vec) override | IBAMR::IBMethod | virtual |
setupSolverVecs(Vec *X_vec, Vec *F_vec) override | IBAMR::IBMethod | virtual |
setupTagBuffer(SAMRAI::tbox::Array< int > &tag_buffer, SAMRAI::tbox::Pointer< SAMRAI::mesh::GriddingAlgorithm< NDIM > > gridding_alg) const override | IBAMR::IBMethod | virtual |
setUseFixedLEOperators(bool use_fixed_coupling_ops=true) | IBAMR::IBStrategy | |
setUseMultistepTimeStepping(unsigned int n_previous_steps=1) | IBAMR::IBStrategy | virtual |
spreadFluidSource(int q_data_idx, IBTK::RobinPhysBdryPatchStrategy *q_phys_bdry_op, const std::vector< SAMRAI::tbox::Pointer< SAMRAI::xfer::RefineSchedule< NDIM > > > &q_prolongation_scheds, double data_time) override | IBAMR::IBMethod | virtual |
spreadForce(int f_data_idx, IBTK::RobinPhysBdryPatchStrategy *f_phys_bdry_op, const std::vector< SAMRAI::tbox::Pointer< SAMRAI::xfer::RefineSchedule< NDIM > > > &f_prolongation_scheds, double data_time) override | IBAMR::IBMethod | virtual |
spreadLinearizedForce(int f_data_idx, IBTK::RobinPhysBdryPatchStrategy *f_phys_bdry_op, const std::vector< SAMRAI::tbox::Pointer< SAMRAI::xfer::RefineSchedule< NDIM > > > &f_prolongation_scheds, double data_time) override | IBAMR::IBMethod | virtual |
StandardTagAndInitStrategy() | SAMRAI::mesh::StandardTagAndInitStrategy< NDIM > | |
trapezoidalStep(double current_time, double new_time) override | IBAMR::IBMethod | virtual |
updateFixedLEOperators() override | IBAMR::IBMethod | virtual |
~IBImplicitStrategy()=default | IBAMR::IBImplicitStrategy | virtual |
~IBMethod() | IBAMR::IBMethod | |
~Serializable() | SAMRAI::tbox::Serializable | virtual |
~StandardTagAndInitStrategy() | SAMRAI::mesh::StandardTagAndInitStrategy< NDIM > | virtual |