IBAMR  IBAMR version 0.19.
IBAMR::CIBMethod Member List

This is the complete list of members for IBAMR::CIBMethod, including all inherited members.

AB2Step(double current_time, double new_time)IBAMR::IBStrategyvirtual
activateLagrangianStructure(int structure_number=0, int level_number=std::numeric_limits< int >::max()) overrideIBAMR::IBMethodvirtual
addWorkloadEstimate(SAMRAI::tbox::Pointer< SAMRAI::hier::PatchHierarchy< NDIM > > hierarchy, const int workload_data_idx) overrideIBAMR::IBMethodvirtual
advanceLevel(const tbox::Pointer< hier::BasePatchLevel< DIM > > level, const tbox::Pointer< hier::BasePatchHierarchy< DIM > > 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) overrideIBAMR::IBMethod
StandardTagAndInitStrategy< NDIM >::applyGradientDetector(const tbox::Pointer< hier::BasePatchHierarchy< DIM > > hierarchy, const int level_number, const double error_data_time, const int tag_index, const bool initial_time, const bool uses_richardson_extrapolation_too)SAMRAI::mesh::StandardTagAndInitStrategy< NDIM >virtual
applyRichardsonExtrapolation(const tbox::Pointer< hier::PatchLevel< DIM > > 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) overrideIBAMR::CIBMethodvirtual
beginDataRedistribution(SAMRAI::tbox::Pointer< SAMRAI::hier::PatchHierarchy< NDIM > > hierarchy, SAMRAI::tbox::Pointer< SAMRAI::mesh::GriddingAlgorithm< NDIM > > gridding_alg) overrideIBAMR::IBMethodvirtual
CIBMethod(std::string object_name, SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > input_db, const int no_structures=1, bool register_for_restart=true)IBAMR::CIBMethod
CIBStrategy(const unsigned int parts)IBAMR::CIBStrategy
CIBStrategy(const CIBStrategy &from)=deleteIBAMR::CIBStrategyprivate
coarsenDataForRichardsonExtrapolation(const tbox::Pointer< hier::PatchHierarchy< DIM > > hierarchy, const int level_number, const tbox::Pointer< hier::PatchLevel< DIM > > coarser_level, const double coarsen_data_time, const bool before_advance)SAMRAI::mesh::StandardTagAndInitStrategy< NDIM >virtual
computeCOMOfStructures(std::vector< Eigen::Vector3d > &center_of_mass, std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > &X_data)IBAMR::CIBMethodprivate
computeForce(Vec X, Vec F)IBAMR::IBMethodprotected
computeForce_SAMRAI(void *ctx, Vec X, Vec F)IBAMR::IBMethodprotectedstatic
computeLagrangianFluidSource(double data_time) overrideIBAMR::IBMethodvirtual
computeLagrangianForce(double data_time) overrideIBAMR::IBMethodvirtual
computeLinearizedLagrangianForce(Vec &X_vec, double data_time) overrideIBAMR::IBMethodvirtual
computeLinearizedResidual(Vec &X_vec, Vec &R_vec) overrideIBAMR::IBMethodvirtual
computeMobilityRegularization(Vec D, Vec L, const double scale=1.0) overrideIBAMR::CIBMethodvirtual
computeNetRigidGeneralizedForce(const unsigned int part, Vec L, IBTK::RigidDOFVector &F) overrideIBAMR::CIBMethodvirtual
computeNetRigidGeneralizedForce(const unsigned int part, Vec L, IBTK::RigidDOFVector &F)=0IBAMR::CIBMethod
computeNetRigidGeneralizedForce(const unsigned int part, Vec L, Vec F)IBAMR::CIBMethod
computeNetRigidGeneralizedForce(Vec L, Vec F, const bool only_free_dofs, const bool only_imposed_dofs, const bool all_dofs=false)IBAMR::CIBMethod
IBAMR::CIBStrategy::computeNetRigidGeneralizedForce(const unsigned int part, Vec L, Vec F)IBAMR::CIBStrategyvirtual
IBAMR::CIBStrategy::computeNetRigidGeneralizedForce(Vec L, Vec F, const bool only_free_dofs, const bool only_imposed_dofs, const bool all_dofs=false)IBAMR::CIBStrategyvirtual
computeResidual(Vec &R_vec) overrideIBAMR::IBMethodvirtual
ConstrainedCOMVelocityFcnPtr typedefIBAMR::CIBMethod
ConstrainedNodalVelocityFcnPtr typedefIBAMR::CIBMethod
constructGeometricMatrix(const std::string &mat_name, Mat &geometric_mat, const std::vector< unsigned > &prototype_struct_ids, const bool initial_time, const int managing_rank) overrideIBAMR::CIBMethodvirtual
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) overrideIBAMR::IBMethodvirtual
constructLagrangianForceJacobian(Mat &A, MatType mat_type, double data_time) overrideIBAMR::IBMethodvirtual
constructMobilityMatrix(const std::string &mat_name, MobilityMatrixType mat_type, Mat &mobility_mat, const std::vector< unsigned > &prototype_struct_ids, const double *grid_dx, const double *domain_extents, const bool initial_time, double rho, double mu, const std::pair< double, double > &scale, double f_periodic_corr, const int managing_rank) overrideIBAMR::CIBMethodvirtual
convertTimeEnumToDouble(IBTK::TimePoint time_pt)IBAMR::IBMethod
copyArrayToVec(Vec b, double *array, const std::vector< unsigned > &struct_ids, const int data_depth, const int array_rank) overrideIBAMR::CIBMethodvirtual
copyFreeDOFsArrayToVec(Vec b, double *array, const std::vector< unsigned > &struct_ids, const int array_rank)IBAMR::CIBStrategyvirtual
copyFreeDOFsVecToArray(Vec b, double *array, const std::vector< unsigned > &struct_ids, const int array_rank)IBAMR::CIBStrategyvirtual
copyVecToArray(Vec b, double *array, const std::vector< unsigned > &struct_ids, const int data_depth, const int array_rank) overrideIBAMR::CIBMethodvirtual
createSolverVecs(Vec *X_vec, Vec *F_vec) overrideIBAMR::IBMethodvirtual
d_anchor_point_local_idxsIBAMR::IBMethodprotected
d_center_of_mass_currentIBAMR::CIBStrategyprotected
d_center_of_mass_halfIBAMR::CIBStrategyprotected
d_center_of_mass_initialIBAMR::CIBStrategyprotected
d_center_of_mass_newIBAMR::CIBStrategyprotected
d_compute_center_of_mass_initialIBAMR::CIBStrategyprotected
d_constrained_velocity_fcns_dataIBAMR::CIBMethodprotected
d_constraint_force_is_initializedIBAMR::CIBMethodprotected
d_current_timeIBAMR::IBMethodprotected
d_do_logIBAMR::IBMethodprotected
d_error_if_points_leave_domainIBAMR::IBMethodprotected
d_eul_lambda_idxIBAMR::CIBMethodprotected
d_eul_lambda_varIBAMR::CIBMethodprotected
d_ext_force_torque_fcn_dataIBAMR::CIBMethodprotected
d_FIBAMR::CIBStrategyprotected
d_F_current_dataIBAMR::IBMethodprotected
d_F_current_needs_ghost_fillIBAMR::IBMethodprotected
d_F_half_dataIBAMR::IBMethodprotected
d_F_half_needs_ghost_fillIBAMR::IBMethodprotected
d_F_jac_dataIBAMR::IBMethodprotected
d_F_jac_needs_ghost_fillIBAMR::IBMethodprotected
d_F_new_dataIBAMR::IBMethodprotected
d_F_new_needs_ghost_fillIBAMR::IBMethodprotected
d_force_jacIBAMR::IBMethodprivate
d_force_jac_data_timeIBAMR::IBMethodprivate
d_force_jac_mffdIBAMR::IBMethodprivate
d_free_dofs_mapIBAMR::CIBStrategyprotected
d_free_dofs_map_updatedIBAMR::CIBStrategyprotected
d_ghostsIBAMR::IBMethodprotected
d_gridding_algIBAMR::IBMethodprotected
d_half_timeIBAMR::IBMethodprotected
d_hierarchyIBAMR::IBMethodprotected
d_ib_force_fcnIBAMR::IBMethodprotected
d_ib_force_fcn_needs_initIBAMR::IBMethodprotected
d_ib_solverIBAMR::IBStrategyprotected
d_ib_source_fcnIBAMR::IBMethodprotected
d_ib_source_fcn_needs_initIBAMR::IBMethodprotected
d_instrument_panelIBAMR::IBMethodprotected
d_interp_kernel_fcnIBAMR::IBMethodprotected
d_l_data_managerIBAMR::IBMethodprotected
d_l_initializerIBAMR::IBMethodprotected
d_lag_velvec_is_initializedIBAMR::CIBMethodprotected
d_lambda_dump_intervalIBAMR::CIBMethodprotected
d_lambda_filenameIBAMR::CIBMethodprotected
d_lambda_streamIBAMR::CIBMethodprotected
d_load_balancerIBAMR::IBMethodprotected
d_n_srcIBAMR::IBMethodprotected
d_net_rigid_generalized_forceIBAMR::CIBStrategyprotected
d_new_timeIBAMR::IBMethodprotected
d_normalize_source_strengthIBAMR::IBMethodprotected
d_num_rigid_partsIBAMR::CIBStrategyprotected
d_object_nameIBAMR::IBMethodprotected
d_output_eul_lambdaIBAMR::CIBMethodprotected
d_P_srcIBAMR::IBMethodprotected
d_post_processorIBAMR::IBMethodprotected
d_prefluidsolve_callback_fcnsIBAMR::CIBMethodprotected
d_prefluidsolve_callback_fcns_ctxIBAMR::CIBMethodprotected
d_Q_srcIBAMR::IBMethodprotected
d_quaternion_currentIBAMR::CIBStrategyprotected
d_quaternion_halfIBAMR::CIBStrategyprotected
d_quaternion_newIBAMR::CIBStrategyprotected
d_r_srcIBAMR::IBMethodprotected
d_reg_filenameIBAMR::CIBMethodprotected
d_registered_for_restartIBAMR::IBMethodprotected
d_rot_vel_currentIBAMR::CIBStrategyprotected
d_rot_vel_halfIBAMR::CIBStrategyprotected
d_rot_vel_newIBAMR::CIBStrategyprotected
d_silo_writerIBAMR::IBMethodprotected
d_solve_rigid_velIBAMR::CIBStrategyprotected
d_spread_kernel_fcnIBAMR::IBMethodprotected
d_struct_lag_idx_rangeIBAMR::CIBMethodprotected
d_time_integrator_needs_regridIBAMR::CIBMethodprotected
d_total_flow_volumeIBAMR::IBMethodprotected
d_trans_vel_currentIBAMR::CIBStrategyprotected
d_trans_vel_halfIBAMR::CIBStrategyprotected
d_trans_vel_newIBAMR::CIBStrategyprotected
d_UIBAMR::CIBStrategyprotected
d_U_current_dataIBAMR::IBMethodprotected
d_U_half_dataIBAMR::IBMethodprotected
d_U_jac_dataIBAMR::IBMethodprotected
d_U_new_dataIBAMR::IBMethodprotected
d_u_phys_bdry_opIBAMR::CIBMethodprotected
d_use_fixed_coupling_opsIBAMR::IBStrategyprotected
d_use_steady_stokesIBAMR::CIBMethodprotected
d_visit_writerIBAMR::CIBMethodprotected
d_workload_idxIBAMR::IBMethodprotected
d_X_current_dataIBAMR::IBMethodprotected
d_X_current_needs_ghost_fillIBAMR::IBMethodprotected
d_X_half_dataIBAMR::IBMethodprotected
d_X_half_needs_ghost_fillIBAMR::IBMethodprotected
d_X_jac_dataIBAMR::IBMethodprotected
d_X_jac_needs_ghost_fillIBAMR::IBMethodprotected
d_X_LE_half_dataIBAMR::IBMethodprotected
d_X_LE_half_needs_ghost_fillIBAMR::IBMethodprotected
d_X_LE_new_dataIBAMR::IBMethodprotected
d_X_LE_new_needs_ghost_fillIBAMR::IBMethodprotected
d_X_new_dataIBAMR::IBMethodprotected
d_X_new_needs_ghost_fillIBAMR::IBMethodprotected
d_X_srcIBAMR::IBMethodprotected
eigenToRDV(const Eigen::Vector3d &U, const Eigen::Vector3d &W, IBTK::RigidDOFVector &UW)IBAMR::CIBStrategystatic
endDataRedistribution(SAMRAI::tbox::Pointer< SAMRAI::hier::PatchHierarchy< NDIM > > hierarchy, SAMRAI::tbox::Pointer< SAMRAI::mesh::GriddingAlgorithm< NDIM > > gridding_alg) overrideIBAMR::IBMethodvirtual
ExternalForceTorqueFcnPtr typedefIBAMR::CIBMethod
flagRegrid() constIBAMR::CIBMethod
forwardEulerStep(double current_time, double new_time) overrideIBAMR::CIBMethodvirtual
freeLInitStrategy()IBAMR::IBMethod
getCoarsenAlgorithm(const std::string &name) constIBAMR::IBStrategyprotected
getCoarsenSchedules(const std::string &name) constIBAMR::IBStrategyprotected
getConstraintForce(Vec *L, const double data_time) overrideIBAMR::CIBMethodvirtual
getCurrentBodyCenterOfMass(const unsigned int part)IBAMR::CIBStrategy
getCurrentRigidBodyVelocity(const unsigned int part, IBTK::RigidDOFVector &U)IBAMR::CIBStrategy
getForceData(std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > **F_data, bool **F_needs_ghost_fill, IBTK::TimePoint time_pt)IBAMR::IBMethod
getForceData(std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > **F_data, bool **F_needs_ghost_fill, double data_time)IBAMR::IBMethodprotected
getFreeRigidVelocities(Vec *U, const double data_time) overrideIBAMR::CIBMethodvirtual
getFromInput(SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > input_db)IBAMR::CIBMethodprivate
getFromRestart()IBAMR::CIBMethodprivate
getGhostfillRefineAlgorithm(const std::string &name) constIBAMR::IBStrategyprotected
getGhostfillRefineSchedules(const std::string &name) constIBAMR::IBStrategyprotected
getHierarchyMathOps() constIBAMR::IBStrategyprotected
getIBInstrumentPanel() constIBAMR::IBMethod
getINSHierarchyIntegrator() constIBAMR::IBStrategyprotected
getInterpolatedVelocity(Vec V, const double data_time, const double scale=1.0) overrideIBAMR::CIBMethodvirtual
getLagrangianStructureIsActivated(int structure_number=0, int level_number=std::numeric_limits< int >::max()) const overrideIBAMR::IBMethodvirtual
getLDataManager() constIBAMR::IBMethod
getLECouplingPositionData(std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > **X_LE_data, bool **X_LE_needs_ghost_fill, double data_time)IBAMR::IBMethodprotected
getLevelDt(const tbox::Pointer< hier::BasePatchLevel< DIM > > 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::IBMethodprotected
getLinearizedPositionData(std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > **X_data, bool **X_needs_ghost_fill)IBAMR::IBMethodprotected
getLinearizedVelocityData(std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > **U_data)IBAMR::IBMethodprotected
getMaxPointDisplacement() constIBAMR::IBStrategyvirtual
getMinimumGhostCellWidth() const overrideIBAMR::IBMethodvirtual
getNetExternalForceTorque(Vec *F, const double data_time) overrideIBAMR::CIBMethodvirtual
getNetRigidGeneralizedForce(const unsigned int part)IBAMR::CIBStrategy
getNewBodyCenterOfMass(const unsigned int part)IBAMR::CIBStrategy
getNewRigidBodyVelocity(const unsigned int part, IBTK::RigidDOFVector &U)IBAMR::CIBStrategy
getNumberOfNodes(const unsigned int part) const overrideIBAMR::CIBMethodvirtual
getNumberOfRigidStructures() constIBAMR::CIBStrategy
getPositionData(std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > **X_data, bool **X_needs_ghost_fill, IBTK::TimePoint time_pt)IBAMR::IBMethod
getPositionData(std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > **X_data, bool **X_needs_ghost_fill, double data_time)IBAMR::IBMethodprotected
getPressureHierarchyDataOps() constIBAMR::IBStrategyprotected
getProlongRefineAlgorithm(const std::string &name) constIBAMR::IBStrategyprotected
getProlongRefineSchedules(const std::string &name) constIBAMR::IBStrategyprotected
getSolveRigidBodyVelocity(const unsigned int part, int &num_free_dofs) constIBAMR::CIBStrategy
getStructureHandle(const int lag_idx) constIBAMR::CIBMethod
getStructuresLevelNumber() constIBAMR::CIBMethod
getVelocityData(std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > **U_data, IBTK::TimePoint time_pt)IBAMR::IBMethod
getVelocityData(std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > **U_data, double data_time)IBAMR::IBMethodprotected
getVelocityHierarchyDataOps() constIBAMR::IBStrategyprotected
hasFluidSources() const overrideIBAMR::IBMethodvirtual
IBImplicitStrategy()=defaultIBAMR::IBImplicitStrategy
IBImplicitStrategy(const IBImplicitStrategy &from)=deleteIBAMR::IBImplicitStrategyprivate
IBMethod(std::string object_name, SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > input_db, bool register_for_restart=true)IBAMR::IBMethod
IBMethod()=deleteIBAMR::IBMethodprivate
IBMethod(const IBMethod &from)=deleteIBAMR::IBMethodprivate
IBStrategy()=defaultIBAMR::IBStrategy
IBStrategy(const IBStrategy &from)=deleteIBAMR::IBStrategyprivate
inactivateLagrangianStructure(int structure_number=0, int level_number=std::numeric_limits< int >::max()) overrideIBAMR::IBMethodvirtual
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) overrideIBAMR::CIBMethod
StandardTagAndInitStrategy< NDIM >::initializeLevelData(const tbox::Pointer< hier::BasePatchHierarchy< DIM > > hierarchy, const int level_number, const double init_data_time, const bool can_be_refined, const bool initial_time, const tbox::Pointer< hier::BasePatchLevel< DIM > > old_level=tbox::Pointer< hier::BasePatchLevel< DIM > >(NULL), const bool allocate_data=true)=0SAMRAI::mesh::StandardTagAndInitStrategy< NDIM >pure 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) overrideIBAMR::CIBMethodvirtual
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) overrideIBAMR::IBMethodvirtual
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) overrideIBAMR::IBMethodvirtual
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) overrideIBAMR::CIBMethodvirtual
midpointStep(double current_time, double new_time) overrideIBAMR::CIBMethodvirtual
IBAMR::operator=(const IBMethod &that)=deleteIBAMR::IBMethodprivate
postprocessData() overrideIBAMR::IBMethodvirtual
postprocessIntegrateData(double current_time, double new_time, int num_cycles) overrideIBAMR::CIBMethodvirtual
postprocessSolveFluidEquations(double current_time, double new_time, int cycle_num)IBAMR::IBStrategyvirtual
preprocessIntegrateData(double current_time, double new_time, int num_cycles) overrideIBAMR::CIBMethodvirtual
preprocessSolveFluidEqn_callbackfcn typedefIBAMR::CIBMethod
preprocessSolveFluidEquations(double current_time, double new_time, int cycle_num) overrideIBAMR::CIBMethodvirtual
putToDatabase(SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > db) overrideIBAMR::CIBMethodvirtual
rdvToEigen(const IBTK::RigidDOFVector &UW, Eigen::Vector3d &U, Eigen::Vector3d &W)IBAMR::CIBStrategystatic
rdvToVec(const IBTK::RigidDOFVector &Ur, Vec &U)IBAMR::CIBStrategystatic
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::IBStrategyprotected
registerConstrainedVelocityFunction(ConstrainedNodalVelocityFcnPtr nodalvelfcn, ConstrainedCOMVelocityFcnPtr comvelfcn, void *ctx=nullptr, unsigned int part=0)IBAMR::CIBMethod
registerConstrainedVelocityFunction(const ConstrainedVelocityFcnsData &data, unsigned int part=0)IBAMR::CIBMethod
registerEulerianCommunicationAlgorithms() overrideIBAMR::CIBMethodvirtual
registerEulerianVariables() overrideIBAMR::CIBMethodvirtual
registerExternalForceTorqueFunction(ExternalForceTorqueFcnPtr forcetorquefcn, void *ctx=nullptr, unsigned int part=0)IBAMR::CIBMethod
registerExternalForceTorqueFunction(const ExternalForceTorqueFcnData &data, unsigned int part=0)IBAMR::CIBMethod
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::IBStrategyprotected
registerIBHierarchyIntegrator(IBHierarchyIntegrator *ib_solver)IBAMR::IBStrategyvirtual
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) overrideIBAMR::IBMethodvirtual
registerLSiloDataWriter(SAMRAI::tbox::Pointer< IBTK::LSiloDataWriter > silo_writer)IBAMR::IBMethod
registerPreProcessSolveFluidEquationsCallBackFcn(preprocessSolveFluidEqn_callbackfcn callback, void *ctx)IBAMR::CIBMethod
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::IBStrategyprotected
registerVariable(int &current_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::IBStrategyprotected
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::IBStrategyprotected
registerVisItDataWriter(SAMRAI::tbox::Pointer< SAMRAI::appu::VisItDataWriter< NDIM > > visit_writer)IBAMR::CIBMethod
reinitMidpointData(const std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > &current_data, const std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > &new_data, const std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > &half_data)IBAMR::IBMethodprotected
resetAnchorPointValues(std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > U_data, int coarsest_ln, int finest_ln)IBAMR::IBMethodprotected
resetDataToPreadvanceState(const tbox::Pointer< hier::BasePatchLevel< DIM > > level)SAMRAI::mesh::StandardTagAndInitStrategy< NDIM >virtual
resetHierarchyConfiguration(SAMRAI::tbox::Pointer< SAMRAI::hier::BasePatchHierarchy< NDIM > > hierarchy, int coarsest_level, int finest_level) overrideIBAMR::IBMethod
StandardTagAndInitStrategy< NDIM >::resetHierarchyConfiguration(const tbox::Pointer< hier::BasePatchHierarchy< DIM > > hierarchy, const int coarsest_level, const int finest_level)=0SAMRAI::mesh::StandardTagAndInitStrategy< NDIM >pure virtual
resetLagrangianForceFunction(double init_data_time, bool initial_time)IBAMR::IBMethodprivate
resetLagrangianSourceFunction(double init_data_time, bool initial_time)IBAMR::IBMethodprivate
resetTimeDependentData(const tbox::Pointer< hier::BasePatchLevel< DIM > > level, const double new_time, const bool can_be_refined)SAMRAI::mesh::StandardTagAndInitStrategy< NDIM >virtual
rotateArray(double *array, const std::vector< unsigned > &struct_ids, const bool use_transpose, const int managing_rank, const int depth) overrideIBAMR::CIBMethodvirtual
Serializable()SAMRAI::tbox::Serializable
setConstraintForce(Vec L, const double data_time, const double scale=1.0) overrideIBAMR::CIBMethodvirtual
setInitialCenterOfMass(const unsigned int part, const Eigen::Vector3d &XCOM_0)IBAMR::CIBStrategy
setInitialLambda(const int level_number)IBAMR::CIBMethodprivate
setInterpolatedVelocityVector(Vec V, const double data_time) overrideIBAMR::CIBMethodvirtual
setLinearizedPosition(Vec &X_vec, double data_time) overrideIBAMR::IBMethodvirtual
setRegularizationWeight(const int level_number)IBAMR::CIBMethodprivate
setRigidBodyVelocity(const unsigned int part, const IBTK::RigidDOFVector &U, Vec V) overrideIBAMR::CIBMethodvirtual
setRigidBodyVelocity(const unsigned int part, const IBTK::RigidDOFVector &U, Vec V)=0IBAMR::CIBMethod
setRigidBodyVelocity(const unsigned int part, Vec U, Vec V)IBAMR::CIBMethod
setRigidBodyVelocity(Vec U, Vec V, const bool only_free_dofs, const bool only_imposed_dofs, const bool all_dofs=false)IBAMR::CIBMethod
IBAMR::CIBStrategy::setRigidBodyVelocity(const unsigned int part, Vec U, Vec V)IBAMR::CIBStrategyvirtual
IBAMR::CIBStrategy::setRigidBodyVelocity(Vec U, Vec V, const bool only_free_dofs, const bool only_imposed_dofs, const bool all_dofs=false)IBAMR::CIBStrategyvirtual
setRotationMatrix(const std::vector< Eigen::Vector3d > &rot_vel, const std::vector< Eigen::Quaterniond > &q_old, std::vector< Eigen::Quaterniond > &q_new, std::vector< Eigen::Matrix3d > &rot_mat, const double dt)IBAMR::CIBStrategyprotected
setSolveRigidBodyVelocity(const unsigned int part, const IBTK::FreeRigidDOFVector &solve_rigid_dofs)IBAMR::CIBStrategy
setUpdatedPosition(Vec &X_new_vec) overrideIBAMR::IBMethodvirtual
setupSolverVecs(Vec *X_vec, Vec *F_vec) overrideIBAMR::IBMethodvirtual
setupTagBuffer(SAMRAI::tbox::Array< int > &tag_buffer, SAMRAI::tbox::Pointer< SAMRAI::mesh::GriddingAlgorithm< NDIM > > gridding_alg) const overrideIBAMR::IBMethodvirtual
setUseFixedLEOperators(bool use_fixed_coupling_ops=true)IBAMR::IBStrategy
setUseMultistepTimeStepping(unsigned int n_previous_steps=1)IBAMR::IBStrategyvirtual
setVelocityPhysBdryOp(IBTK::RobinPhysBdryPatchStrategy *u_phys_bdry_op)IBAMR::CIBMethod
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) overrideIBAMR::IBMethodvirtual
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) overrideIBAMR::CIBMethodvirtual
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) overrideIBAMR::IBMethodvirtual
StandardTagAndInitStrategy()SAMRAI::mesh::StandardTagAndInitStrategy< NDIM >
subtractMeanConstraintForce(Vec L, int f_data_idx, const double scale=1.0) overrideIBAMR::CIBMethodvirtual
trapezoidalStep(double current_time, double new_time) overrideIBAMR::CIBMethodvirtual
updateFixedLEOperators() overrideIBAMR::IBMethodvirtual
updateFreeDOFsMapping()IBAMR::CIBStrategy
updateIBInstrumentationData(int timestep_num, double data_time)IBAMR::IBMethodprivate
updateNewRigidBodyVelocity(const unsigned int part, const IBTK::RigidDOFVector &U)IBAMR::CIBStrategy
updateNewRigidBodyVelocity(const unsigned int part, Vec U)IBAMR::CIBStrategy
updateNewRigidBodyVelocity(Vec U, const bool only_free_dofs, const bool only_imposed_dofs, const bool all_dofs=false)IBAMR::CIBStrategy
vecToRDV(Vec U, IBTK::RigidDOFVector &Ur)IBAMR::CIBStrategystatic
~CIBMethod()IBAMR::CIBMethod
~CIBStrategy()IBAMR::CIBStrategyvirtual
~DescribedClass()SAMRAI::tbox::DescribedClassvirtual
~IBImplicitStrategy()=defaultIBAMR::IBImplicitStrategyvirtual
~IBMethod()IBAMR::IBMethod
~Serializable()SAMRAI::tbox::Serializablevirtual
~StandardTagAndInitStrategy()SAMRAI::mesh::StandardTagAndInitStrategy< NDIM >virtual