|
IBAMR
IBAMR version 0.19.
|
This is the complete list of members for IBAMR::CIBMethod, 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< 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) override | IBAMR::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) override | IBAMR::CIBMethod | virtual |
| beginDataRedistribution(SAMRAI::tbox::Pointer< SAMRAI::hier::PatchHierarchy< NDIM > > hierarchy, SAMRAI::tbox::Pointer< SAMRAI::mesh::GriddingAlgorithm< NDIM > > gridding_alg) override | IBAMR::IBMethod | virtual |
| 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)=delete | IBAMR::CIBStrategy | private |
| 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 > ¢er_of_mass, std::vector< SAMRAI::tbox::Pointer< IBTK::LData > > &X_data) | IBAMR::CIBMethod | private |
| computeForce(Vec X, Vec F) | IBAMR::IBMethod | protected |
| computeForce_SAMRAI(void *ctx, Vec X, Vec F) | 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 |
| computeMobilityRegularization(Vec D, Vec L, const double scale=1.0) override | IBAMR::CIBMethod | virtual |
| computeNetRigidGeneralizedForce(const unsigned int part, Vec L, IBTK::RigidDOFVector &F) override | IBAMR::CIBMethod | virtual |
| computeNetRigidGeneralizedForce(const unsigned int part, Vec L, IBTK::RigidDOFVector &F)=0 | IBAMR::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::CIBStrategy | virtual |
| IBAMR::CIBStrategy::computeNetRigidGeneralizedForce(Vec L, Vec F, const bool only_free_dofs, const bool only_imposed_dofs, const bool all_dofs=false) | IBAMR::CIBStrategy | virtual |
| computeResidual(Vec &R_vec) override | IBAMR::IBMethod | virtual |
| ConstrainedCOMVelocityFcnPtr typedef | IBAMR::CIBMethod | |
| ConstrainedNodalVelocityFcnPtr typedef | IBAMR::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) override | IBAMR::CIBMethod | 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 |
| 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) override | IBAMR::CIBMethod | virtual |
| 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) override | IBAMR::CIBMethod | virtual |
| copyFreeDOFsArrayToVec(Vec b, double *array, const std::vector< unsigned > &struct_ids, const int array_rank) | IBAMR::CIBStrategy | virtual |
| copyFreeDOFsVecToArray(Vec b, double *array, const std::vector< unsigned > &struct_ids, const int array_rank) | IBAMR::CIBStrategy | virtual |
| copyVecToArray(Vec b, double *array, const std::vector< unsigned > &struct_ids, const int data_depth, const int array_rank) override | IBAMR::CIBMethod | virtual |
| createSolverVecs(Vec *X_vec, Vec *F_vec) override | IBAMR::IBMethod | virtual |
| d_anchor_point_local_idxs | IBAMR::IBMethod | protected |
| d_center_of_mass_current | IBAMR::CIBStrategy | protected |
| d_center_of_mass_half | IBAMR::CIBStrategy | protected |
| d_center_of_mass_initial | IBAMR::CIBStrategy | protected |
| d_center_of_mass_new | IBAMR::CIBStrategy | protected |
| d_compute_center_of_mass_initial | IBAMR::CIBStrategy | protected |
| d_constrained_velocity_fcns_data | IBAMR::CIBMethod | protected |
| d_constraint_force_is_initialized | IBAMR::CIBMethod | protected |
| d_current_time | IBAMR::IBMethod | protected |
| d_do_log | IBAMR::IBMethod | protected |
| d_error_if_points_leave_domain | IBAMR::IBMethod | protected |
| d_eul_lambda_idx | IBAMR::CIBMethod | protected |
| d_eul_lambda_var | IBAMR::CIBMethod | protected |
| d_ext_force_torque_fcn_data | IBAMR::CIBMethod | protected |
| d_F | IBAMR::CIBStrategy | protected |
| d_F_current_data | IBAMR::IBMethod | protected |
| d_F_current_needs_ghost_fill | IBAMR::IBMethod | protected |
| d_F_half_data | IBAMR::IBMethod | protected |
| d_F_half_needs_ghost_fill | IBAMR::IBMethod | protected |
| d_F_jac_data | IBAMR::IBMethod | protected |
| d_F_jac_needs_ghost_fill | IBAMR::IBMethod | protected |
| d_F_new_data | IBAMR::IBMethod | protected |
| d_F_new_needs_ghost_fill | IBAMR::IBMethod | protected |
| d_force_jac | IBAMR::IBMethod | private |
| d_force_jac_data_time | IBAMR::IBMethod | private |
| d_force_jac_mffd | IBAMR::IBMethod | private |
| d_free_dofs_map | IBAMR::CIBStrategy | protected |
| d_free_dofs_map_updated | IBAMR::CIBStrategy | protected |
| d_ghosts | IBAMR::IBMethod | protected |
| d_gridding_alg | IBAMR::IBMethod | protected |
| d_half_time | IBAMR::IBMethod | protected |
| d_hierarchy | IBAMR::IBMethod | protected |
| d_ib_force_fcn | IBAMR::IBMethod | protected |
| d_ib_force_fcn_needs_init | IBAMR::IBMethod | protected |
| d_ib_solver | IBAMR::IBStrategy | protected |
| d_ib_source_fcn | IBAMR::IBMethod | protected |
| d_ib_source_fcn_needs_init | IBAMR::IBMethod | protected |
| d_instrument_panel | IBAMR::IBMethod | protected |
| d_interp_kernel_fcn | IBAMR::IBMethod | protected |
| d_l_data_manager | IBAMR::IBMethod | protected |
| d_l_initializer | IBAMR::IBMethod | protected |
| d_lag_velvec_is_initialized | IBAMR::CIBMethod | protected |
| d_lambda_dump_interval | IBAMR::CIBMethod | protected |
| d_lambda_filename | IBAMR::CIBMethod | protected |
| d_lambda_stream | IBAMR::CIBMethod | protected |
| d_load_balancer | IBAMR::IBMethod | protected |
| d_n_src | IBAMR::IBMethod | protected |
| d_net_rigid_generalized_force | IBAMR::CIBStrategy | protected |
| d_new_time | IBAMR::IBMethod | protected |
| d_normalize_source_strength | IBAMR::IBMethod | protected |
| d_num_rigid_parts | IBAMR::CIBStrategy | protected |
| d_object_name | IBAMR::IBMethod | protected |
| d_output_eul_lambda | IBAMR::CIBMethod | protected |
| d_P_src | IBAMR::IBMethod | protected |
| d_post_processor | IBAMR::IBMethod | protected |
| d_prefluidsolve_callback_fcns | IBAMR::CIBMethod | protected |
| d_prefluidsolve_callback_fcns_ctx | IBAMR::CIBMethod | protected |
| d_Q_src | IBAMR::IBMethod | protected |
| d_quaternion_current | IBAMR::CIBStrategy | protected |
| d_quaternion_half | IBAMR::CIBStrategy | protected |
| d_quaternion_new | IBAMR::CIBStrategy | protected |
| d_r_src | IBAMR::IBMethod | protected |
| d_reg_filename | IBAMR::CIBMethod | protected |
| d_registered_for_restart | IBAMR::IBMethod | protected |
| d_rot_vel_current | IBAMR::CIBStrategy | protected |
| d_rot_vel_half | IBAMR::CIBStrategy | protected |
| d_rot_vel_new | IBAMR::CIBStrategy | protected |
| d_silo_writer | IBAMR::IBMethod | protected |
| d_solve_rigid_vel | IBAMR::CIBStrategy | protected |
| d_spread_kernel_fcn | IBAMR::IBMethod | protected |
| d_struct_lag_idx_range | IBAMR::CIBMethod | protected |
| d_time_integrator_needs_regrid | IBAMR::CIBMethod | protected |
| d_total_flow_volume | IBAMR::IBMethod | protected |
| d_trans_vel_current | IBAMR::CIBStrategy | protected |
| d_trans_vel_half | IBAMR::CIBStrategy | protected |
| d_trans_vel_new | IBAMR::CIBStrategy | protected |
| d_U | IBAMR::CIBStrategy | protected |
| d_U_current_data | IBAMR::IBMethod | protected |
| d_U_half_data | IBAMR::IBMethod | protected |
| d_U_jac_data | IBAMR::IBMethod | protected |
| d_U_new_data | IBAMR::IBMethod | protected |
| d_u_phys_bdry_op | IBAMR::CIBMethod | protected |
| d_use_fixed_coupling_ops | IBAMR::IBStrategy | protected |
| d_use_steady_stokes | IBAMR::CIBMethod | protected |
| d_visit_writer | IBAMR::CIBMethod | protected |
| d_workload_idx | IBAMR::IBMethod | protected |
| d_X_current_data | IBAMR::IBMethod | protected |
| d_X_current_needs_ghost_fill | IBAMR::IBMethod | protected |
| d_X_half_data | IBAMR::IBMethod | protected |
| d_X_half_needs_ghost_fill | IBAMR::IBMethod | protected |
| d_X_jac_data | IBAMR::IBMethod | protected |
| d_X_jac_needs_ghost_fill | IBAMR::IBMethod | protected |
| d_X_LE_half_data | IBAMR::IBMethod | protected |
| d_X_LE_half_needs_ghost_fill | IBAMR::IBMethod | protected |
| d_X_LE_new_data | IBAMR::IBMethod | protected |
| d_X_LE_new_needs_ghost_fill | IBAMR::IBMethod | protected |
| d_X_new_data | IBAMR::IBMethod | protected |
| d_X_new_needs_ghost_fill | IBAMR::IBMethod | protected |
| d_X_src | IBAMR::IBMethod | protected |
| eigenToRDV(const Eigen::Vector3d &U, const Eigen::Vector3d &W, IBTK::RigidDOFVector &UW) | IBAMR::CIBStrategy | static |
| endDataRedistribution(SAMRAI::tbox::Pointer< SAMRAI::hier::PatchHierarchy< NDIM > > hierarchy, SAMRAI::tbox::Pointer< SAMRAI::mesh::GriddingAlgorithm< NDIM > > gridding_alg) override | IBAMR::IBMethod | virtual |
| ExternalForceTorqueFcnPtr typedef | IBAMR::CIBMethod | |
| flagRegrid() const | IBAMR::CIBMethod | |
| forwardEulerStep(double current_time, double new_time) override | IBAMR::CIBMethod | virtual |
| freeLInitStrategy() | IBAMR::IBMethod | |
| getCoarsenAlgorithm(const std::string &name) const | IBAMR::IBStrategy | protected |
| getCoarsenSchedules(const std::string &name) const | IBAMR::IBStrategy | protected |
| getConstraintForce(Vec *L, const double data_time) override | IBAMR::CIBMethod | virtual |
| 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::IBMethod | protected |
| getFreeRigidVelocities(Vec *U, const double data_time) override | IBAMR::CIBMethod | virtual |
| getFromInput(SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > input_db) | IBAMR::CIBMethod | private |
| getFromRestart() | IBAMR::CIBMethod | private |
| 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 |
| getInterpolatedVelocity(Vec V, const double data_time, const double scale=1.0) override | IBAMR::CIBMethod | virtual |
| 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< 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::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 |
| getNetExternalForceTorque(Vec *F, const double data_time) override | IBAMR::CIBMethod | virtual |
| 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 override | IBAMR::CIBMethod | virtual |
| getNumberOfRigidStructures() const | IBAMR::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::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 |
| getSolveRigidBodyVelocity(const unsigned int part, int &num_free_dofs) const | IBAMR::CIBStrategy | |
| getStructureHandle(const int lag_idx) const | IBAMR::CIBMethod | |
| getStructuresLevelNumber() const | IBAMR::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::IBMethod | protected |
| getVelocityHierarchyDataOps() const | IBAMR::IBStrategy | protected |
| hasFluidSources() const override | IBAMR::IBMethod | virtual |
| IBImplicitStrategy()=default | IBAMR::IBImplicitStrategy | |
| IBImplicitStrategy(const IBImplicitStrategy &from)=delete | IBAMR::IBImplicitStrategy | private |
| IBMethod(std::string object_name, SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > input_db, bool register_for_restart=true) | IBAMR::IBMethod | |
| IBMethod()=delete | IBAMR::IBMethod | private |
| IBMethod(const IBMethod &from)=delete | IBAMR::IBMethod | private |
| IBStrategy()=default | IBAMR::IBStrategy | |
| IBStrategy(const IBStrategy &from)=delete | IBAMR::IBStrategy | private |
| 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::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)=0 | SAMRAI::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) override | IBAMR::CIBMethod | 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::CIBMethod | virtual |
| midpointStep(double current_time, double new_time) override | IBAMR::CIBMethod | virtual |
| IBAMR::operator=(const IBMethod &that)=delete | IBAMR::IBMethod | private |
| postprocessData() override | IBAMR::IBMethod | virtual |
| postprocessIntegrateData(double current_time, double new_time, int num_cycles) override | IBAMR::CIBMethod | 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::CIBMethod | virtual |
| preprocessSolveFluidEqn_callbackfcn typedef | IBAMR::CIBMethod | |
| preprocessSolveFluidEquations(double current_time, double new_time, int cycle_num) override | IBAMR::CIBMethod | virtual |
| putToDatabase(SAMRAI::tbox::Pointer< SAMRAI::tbox::Database > db) override | IBAMR::CIBMethod | virtual |
| rdvToEigen(const IBTK::RigidDOFVector &UW, Eigen::Vector3d &U, Eigen::Vector3d &W) | IBAMR::CIBStrategy | static |
| rdvToVec(const IBTK::RigidDOFVector &Ur, Vec &U) | IBAMR::CIBStrategy | static |
| 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 |
| 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() override | IBAMR::CIBMethod | virtual |
| registerEulerianVariables() override | IBAMR::CIBMethod | virtual |
| 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::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 | |
| 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::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 |
| registerVisItDataWriter(SAMRAI::tbox::Pointer< SAMRAI::appu::VisItDataWriter< NDIM > > visit_writer) | IBAMR::CIBMethod | |
| 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< DIM > > level) | SAMRAI::mesh::StandardTagAndInitStrategy< NDIM > | virtual |
| resetHierarchyConfiguration(SAMRAI::tbox::Pointer< SAMRAI::hier::BasePatchHierarchy< NDIM > > hierarchy, int coarsest_level, int finest_level) override | IBAMR::IBMethod | |
| StandardTagAndInitStrategy< NDIM >::resetHierarchyConfiguration(const tbox::Pointer< hier::BasePatchHierarchy< DIM > > hierarchy, const int coarsest_level, const int finest_level)=0 | SAMRAI::mesh::StandardTagAndInitStrategy< NDIM > | pure virtual |
| resetLagrangianForceFunction(double init_data_time, bool initial_time) | IBAMR::IBMethod | private |
| resetLagrangianSourceFunction(double init_data_time, bool initial_time) | IBAMR::IBMethod | private |
| 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) override | IBAMR::CIBMethod | virtual |
| Serializable() | SAMRAI::tbox::Serializable | |
| setConstraintForce(Vec L, const double data_time, const double scale=1.0) override | IBAMR::CIBMethod | virtual |
| setInitialCenterOfMass(const unsigned int part, const Eigen::Vector3d &XCOM_0) | IBAMR::CIBStrategy | |
| setInitialLambda(const int level_number) | IBAMR::CIBMethod | private |
| setInterpolatedVelocityVector(Vec V, const double data_time) override | IBAMR::CIBMethod | virtual |
| setLinearizedPosition(Vec &X_vec, double data_time) override | IBAMR::IBMethod | virtual |
| setRegularizationWeight(const int level_number) | IBAMR::CIBMethod | private |
| setRigidBodyVelocity(const unsigned int part, const IBTK::RigidDOFVector &U, Vec V) override | IBAMR::CIBMethod | virtual |
| setRigidBodyVelocity(const unsigned int part, const IBTK::RigidDOFVector &U, Vec V)=0 | IBAMR::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::CIBStrategy | virtual |
| IBAMR::CIBStrategy::setRigidBodyVelocity(Vec U, Vec V, const bool only_free_dofs, const bool only_imposed_dofs, const bool all_dofs=false) | IBAMR::CIBStrategy | virtual |
| 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::CIBStrategy | protected |
| setSolveRigidBodyVelocity(const unsigned int part, const IBTK::FreeRigidDOFVector &solve_rigid_dofs) | IBAMR::CIBStrategy | |
| 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 |
| 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) 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::CIBMethod | 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 > | |
| subtractMeanConstraintForce(Vec L, int f_data_idx, const double scale=1.0) override | IBAMR::CIBMethod | virtual |
| trapezoidalStep(double current_time, double new_time) override | IBAMR::CIBMethod | virtual |
| updateFixedLEOperators() override | IBAMR::IBMethod | virtual |
| updateFreeDOFsMapping() | IBAMR::CIBStrategy | |
| updateIBInstrumentationData(int timestep_num, double data_time) | IBAMR::IBMethod | private |
| 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::CIBStrategy | static |
| ~CIBMethod() | IBAMR::CIBMethod | |
| ~CIBStrategy() | IBAMR::CIBStrategy | virtual |
| ~DescribedClass() | SAMRAI::tbox::DescribedClass | virtual |
| ~IBImplicitStrategy()=default | IBAMR::IBImplicitStrategy | virtual |
| ~IBMethod() | IBAMR::IBMethod | |
| ~Serializable() | SAMRAI::tbox::Serializable | virtual |
| ~StandardTagAndInitStrategy() | SAMRAI::mesh::StandardTagAndInitStrategy< NDIM > | virtual |
1.8.17