API reference#
Writing and running a simulation with Siconos may be achieved either with C++ language or with the python interface. Although those two APIs are quite similar, two different documentations (both generated from sources) are available. Please pick the one corresponding to the interface you choose. Below you will find links to documentation for all classes and files in Siconos, sorted by component or module name.
Siconos C/C++ API reference#
This is the documentation of C/C++ interface to Siconos.
- Class diagrams (UML view)
- Numerics: a collection of low-level algorithms for solving basic algebra and optimization problem arising in the simulation of nonsmooth dynamical systems.
- Kernel: high-level API to modelise and simulate nonsmooth dynamical systems.
- Control: control toolbox
- Mechanics: toolbox for collision detection and joints
- Io: tools related to input/outputs (hdf5, vtk …)
Siconos Python API reference#
This is the documentation of python interface to Siconos.
- siconos.numerics: a collection of low-level algorithms for solving basic algebra and optimization problem arising in the simulation of nonsmooth dynamical systems.
linearComplementarity_driver()
mlcp_driver()
fc2d_driver()
fc3d_driver()
rolling_fc3d_driver()
rolling_fc2d_driver()
gfc2d_driver()
gfc3d_driver()
g_rolling_fc3d_driver()
variationalInequality_driver()
avi_driver()
mcp_old_driver()
mcp_driver()
ncp_driver()
soclcp_driver()
fc3d_LmgcDriver()
gfc3d_LmgcDriver()
relay_driver()
Callback
SolverOptions
SolverOptions.solverId
SolverOptions.isSet
SolverOptions.iSize
SolverOptions.iparam
SolverOptions.dSize
SolverOptions.dparam
SolverOptions.filterOn
SolverOptions.dWorkSize
SolverOptions.dWork
SolverOptions.iWorkSize
SolverOptions.iWork
SolverOptions.numberOfInternalSolvers
SolverOptions.internalSolvers
SolverOptions.callback
SolverOptions.solverParameters
SolverOptions.solverData
SICONOS_ERROR_FULL_EVALUATION
SICONOS_ERROR_LIGHT_EVALUATION
SICONOS_ERROR_LIGHT_EVALUATION_NO_UPDATE
solver_options_print()
solver_options_delete()
solver_options_create()
solver_options_copy()
solver_options_update_internal()
solver_options_name_to_id()
solver_options_id_to_name()
solver_options_get_internal_solver()
solver_options_set_internal_solver()
numerics_error()
numerics_error_nonfatal()
numerics_warning()
numerics_printf()
numerics_printf_verbose()
CSparseMatrix_factors
CSparseMatrix_lu_factorization()
CSparseMatrix_chol_factorization()
CSparseMatrix_ldlt_factorization()
CSparseMatrix_solve()
CSparseMatrix_spsolve()
CSparseMatrix_chol_solve()
CSparseMatrix_chol_spsolve()
CSparseMatrix_ldlt_solve()
CSparseMatrix_free_lu_factors()
CSparseMatrix_aaxpby()
CSparseMatrix_alloc_for_copy()
CSparseMatrix_print()
CSparseMatrix_print_in_file()
CSparseMatrix_zentry()
CSparseMatrix_symmetric_zentry()
CSparseMatrix_entry()
CSparseMatrix_symmetric_entry()
CSparseMatrix_check_triplet()
CSparseMatrix_check_csc()
CSparseMatrix_spfree_on_stack()
CSparseMatrix_copy()
CSparseMatrix_scal()
CSparseMatrix_get_value()
CSparseMatrix_write_in_file_python()
CSparseMatrix_max_by_columns()
CSparseMatrix_max_abs_by_columns()
SparseBlockStructuredMatrix
SBM_new()
SBM_null()
SBM_gemv()
SBM_gemv_3x3()
SBM_gemm_without_allocation()
SBM_multiply()
SBM_zero_matrix_for_multiply()
SBM_add()
SBM_add_without_allocation()
SBM_scal()
SBM_row_prod()
SBM_row_prod_no_diag()
SBM_row_prod_no_diag_3x3()
SBM_clear()
SBMfree()
SBM_print()
SBM_write_in_file()
SBM_read_in_file()
SBM_new_from_file()
SBM_write_in_fileForScilab()
SBM_write_in_filename()
SBM_read_in_filename()
SBM_clear_pred()
SBM_diagonal_block_indices()
SBM_diagonal_block_index()
SBM_entry()
SBM_get_value()
SBM_copy()
SBM_transpose()
SBM_inverse_diagonal_block_matrix_in_place()
SBM_to_dense()
SBM_to_sparse()
SBM_to_sparse_init_memory()
SBM_row_permutation()
SBM_column_permutation()
SBCM_new_3x3()
SBCM_free_3x3()
SBCM_to_SBM()
SBM_free_from_SBCM()
SBM_from_csparse()
NumericsMatrixInternalData
NumericsMatrixInternalData.iWorkSize
NumericsMatrixInternalData.iWork
NumericsMatrixInternalData.sizeof_elt
NumericsMatrixInternalData.dWorkSize
NumericsMatrixInternalData.dWork
NumericsMatrixInternalData.isLUfactorized
NumericsMatrixInternalData.isCholeskyfactorized
NumericsMatrixInternalData.isLDLTfactorized
NumericsMatrixInternalData.isInversed
NM_DENSE
NM_SPARSE_BLOCK
NM_SPARSE
NM_UNKNOWN
NumericsMatrix
NM_NONE
NM_KEEP_FACTORS
NM_PRESERVE
NM_new()
NM_create()
NM_create_from_data()
NM_version_copy()
NM_copy()
NM_copy_to_sparse()
NM_duplicate()
numericsSparseMatrix()
NM_triplet()
NM_half_triplet()
NM_csc()
NM_csc_trans()
NM_csr()
NM_fill()
NM_new_SBM()
NM_transpose()
NM_null()
NM_destructible()
NM_preserve()
NM_unpreserve()
NM_LU_factorized()
NM_Cholesky_factorized()
NM_LDLT_factorized()
NM_set_LU_factorized()
NM_update_size()
NM_csc_alloc()
NM_csc_empty_alloc()
NM_triplet_alloc()
NM_clear()
NM_clear_not_dense()
NM_clear_not_SBM()
NM_clear_other_storages()
NM_zentry()
NM_entry()
NM_get_value()
NM_equal()
NM_compare()
NM_nnz()
NM_extract_diag_block()
NM_extract_diag_block3()
NM_extract_diag_block2()
NM_extract_diag_block5()
NM_copy_diag_block3()
NM_insert()
NM_prod_mv_3x3()
NM_row_prod()
NM_row_prod_no_diag()
NM_row_prod_no_diag3()
NM_row_prod_no_diag2()
NM_gemv()
NM_gemm()
NM_multiply()
NM_tgemv()
NM_to_dense()
NM_dense_display_matlab()
NM_dense_display()
NM_vector_display()
NM_display()
NM_display_storageType()
NM_display_row_by_row()
NM_write_in_filename()
NM_read_in_filename()
NM_write_in_file()
NM_read_in_file()
NM_new_from_file()
NM_write_in_file_scilab()
NM_write_in_file_python()
NM_read_in_file_scilab()
NM_clearDense()
NM_clearSparseBlock()
NM_clearSparse()
NM_clearTriplet()
NM_clearHalfTriplet()
NM_clearCSC()
NM_clearCSCTranspose()
NM_clearCSR()
NM_clearSparseStorage()
NM_LU_factorize()
NM_LU_solve()
NM_LU_inv()
NM_inverse_diagonal_block_matrix()
NM_gesv()
NM_gesv_inv()
NM_setSparseSolver()
NM_internalData()
NM_internalData_new()
NM_internalData_copy()
NM_iWork()
NM_dWork()
NM_add_to_diag3()
NM_add_to_diag5()
NM_add()
NM_scal()
NM_assert()
NM_check()
NM_norm_1()
NM_norm_inf()
NM_convert()
NM_iterated_power_method()
NM_max_by_columns()
NM_max_by_rows()
NM_max_abs_by_columns()
NM_max_abs_by_rows()
NM_compute_balancing_matrices()
NM_BalancingMatrices_new()
NM_BalancingMatrices_free()
NM_reset_version()
NM_reset_versions()
linalg_data_t
NSM_linear_solver_params
NumericsSparseMatrix
NSM_null()
NSM_new()
NSM_clear()
NSM_version_copy()
NSM_copy()
NSM_clear_p()
NSM_data()
NSM_linear_solver_data()
NSM_workspace()
NSM_nnz()
NSM_diag_indices()
NSM_extract_block()
NSM_linearSolverParams_free()
NSM_linearSolverParams_new()
NSM_linearSolverParams()
NSM_fix_csc()
NSM_origin()
NSM_get_origin()
NSM_new_from_file()
NSM_version()
NSM_latest_id()
NSM_max_version()
NSM_set_version()
NSM_reset_versions()
NSM_reset_version()
NSM_inc_version()
NSM_latest()
NSM_version_sync()
NM_MUMPS_copy()
MLCP
mixedLinearComplementarity_free()
mixedLinearComplementarity_new()
mixedLinearComplementarity_display()
mixedLinearComplementarity_printInFile()
mixedLinearComplementarity_newFromFile()
mixedLinearComplementarity_newFromFileOld()
mixedLinearComplementarity_newFromFilename()
mixedLinearComplementarity_fromMtoABCD()
mlcp_driver_init()
mlcp_driver_reset()
mlcp_pgs()
mlcp_rpgs()
mlcp_psor()
mlcp_rpsor()
mlcp_path()
mlcp_enum()
mlcp_direct()
mlcp_direct_enum()
mlcp_direct_simplex()
mlcp_direct_path()
mlcp_simplex()
mlcp_FB()
mlcp_direct_FB()
mlcp_pgs_SBM()
mlcp_compute_error()
LCP
linearComplementarity_display()
linearComplementarity_printInFile()
linearComplementarity_newFromFile()
linearComplementarity_newFromFilename()
freeLinearComplementarityProblem()
newLCP()
lcp_qp()
lcp_cpg()
lcp_pgs()
lcp_rpgs()
lcp_psor()
lcp_nsqp()
lcp_latin()
lcp_latin_w()
lcp_lexicolemke()
lcp_newton_min()
lcp_newton_FB()
lcp_newton_minFB()
lcp_path()
lcp_enum()
lcp_enum_init()
lcp_enum_reset()
lcp_avi_caoferris()
lcp_pivot()
lcp_pathsearch()
lcp_gams()
lcp_nsgs_SBM()
lcp_nsgs_SBM_buildLocalProblem()
lcp_compute_error()
lcp_driver_DenseMatrix()
SICONOS_LCP_IPARAM_NSGS_ITERATIONS_SUM
SICONOS_LCP_IPARAM_PIVOTING_METHOD_TYPE
SICONOS_LCP_IPARAM_SKIP_TRIVIAL
SICONOS_LCP_IPARAM_ENUM_NUMBER_OF_SOLUTIONS
SICONOS_LCP_IPARAM_ENUM_CURRENT_ENUM
SICONOS_LCP_IPARAM_ENUM_SEED
SICONOS_LCP_IPARAM_ENUM_USE_DGELS
SICONOS_LCP_IPARAM_ENUM_MULTIPLE_SOLUTIONS
SICONOS_LCP_DPARAM_RHO
SICONOS_LCP_DPARAM_NSGS_LOCAL_ERROR_SUM
SICONOS_LCP_DPARAM_LATIN_PARAMETER
AVI
AVI_display()
AVI_printInFile()
AVI_newFromFile()
AVI_newFromFilename()
freeAVI()
newAVI()
avi_caoferris()
avi_pathavi()
SICONOS_FRICTION_2D_NSGS
SICONOS_FRICTION_3D_NSGS
SICONOS_FRICTION_3D_NSGSV
SICONOS_FRICTION_3D_PROX
SICONOS_FRICTION_3D_TFP
SICONOS_FRICTION_3D_NSN_AC
SICONOS_FRICTION_3D_DSFP
SICONOS_FRICTION_3D_VI_FPP
SICONOS_FRICTION_3D_VI_EG
SICONOS_FRICTION_3D_HP
SICONOS_FRICTION_3D_NCPGlockerFBFixedPoint
SICONOS_FRICTION_3D_FPP
SICONOS_FRICTION_3D_EG
SICONOS_FRICTION_3D_NSN_FB
SICONOS_FRICTION_3D_GAMS_PATH
SICONOS_FRICTION_3D_GAMS_PATHVI
SICONOS_FRICTION_3D_ACLMFP
SICONOS_FRICTION_3D_SOCLCP
SICONOS_FRICTION_3D_GAMS_LCP_PATH
SICONOS_FRICTION_3D_GAMS_LCP_PATHVI
SICONOS_FRICTION_3D_NSN_NM
SICONOS_FRICTION_3D_PFP
SICONOS_FRICTION_3D_ADMM
SICONOS_FRICTION_3D_ONECONTACT_NSN
SICONOS_FRICTION_3D_ONECONTACT_NSN_GP
SICONOS_FRICTION_3D_ONECONTACT_ProjectionOnCone
SICONOS_FRICTION_3D_ONECONTACT_ProjectionOnConeWithLocalIteration
SICONOS_FRICTION_3D_NCPGlockerFBPATH
SICONOS_FRICTION_3D_NCPGlockerFBNewton
SICONOS_GLOBAL_FRICTION_3D_NSGS_WR
SICONOS_GLOBAL_FRICTION_3D_VI_FPP
SICONOS_GLOBAL_FRICTION_3D_VI_EG
SICONOS_ROLLING_FRICTION_3D_NSGS
SICONOS_ROLLING_FRICTION_2D_NSGS
SICONOS_GLOBAL_ROLLING_FRICTION_3D_NSGS_WR
SICONOS_FRICTION_3D_IPARAM_INTERNAL_ERROR_STRATEGY
SICONOS_FRICTION_3D_IPARAM_RESCALING
SICONOS_FRICTION_3D_IPARAM_RESCALING_CONE
SICONOS_FRICTION_3D_CURRENT_CONTACT_NUMBER
SICONOS_FRICTION_3D_IPARAM_ERROR_EVALUATION
SICONOS_FRICTION_3D_IPARAM_ERROR_EVALUATION_FREQUENCY
SICONOS_FRICTION_3D_DPARAM_INTERNAL_ERROR_RATIO
SICONOS_FRICTION_3D_NSGS_RELAXATION
SICONOS_FRICTION_3D_NSGS_SHUFFLE
SICONOS_FRICTION_3D_NSGS_SHUFFLE_SEED
SICONOS_FRICTION_3D_NSGS_FREEZING_CONTACT
SICONOS_FRICTION_3D_NSGS_FILTER_LOCAL_SOLUTION
SICONOS_FRICTION_3D_NSGS_RELAXATION_VALUE
SICONOS_FRICTION_3D_NSGS_ERROR_EVALUATION_FULL
SICONOS_FRICTION_3D_NSGS_ERROR_EVALUATION_LIGHT
SICONOS_FRICTION_3D_NSGS_ERROR_EVALUATION_LIGHT_WITH_FULL_FINAL
SICONOS_FRICTION_3D_NSGS_ERROR_EVALUATION_ADAPTIVE
SICONOS_FRICTION_3D_NSN_RHO_STRATEGY
SICONOS_FRICTION_3D_NSN_FORMULATION
SICONOS_FRICTION_3D_NSN_LINESEARCH
SICONOS_FRICTION_3D_NSN_LINESEARCH_MAX_ITER
SICONOS_FRICTION_3D_NSN_LINEAR_SOLVER
SICONOS_FRICTION_3D_NSN_HYBRID_STRATEGY
SICONOS_FRICTION_3D_NSN_HYBRID_MAX_LOOP
SICONOS_FRICTION_3D_NSN_HYBRID_MAX_ITER
SICONOS_FRICTION_3D_NSN_MEMORY_ALLOCATED
SICONOS_FRICTION_3D_NSN_MPI_COM
SICONOS_FRICTION_3D_NSN_RHO
SICONOS_FRICTION_3D_NSN_FORMULATION_RHO_STRATEGY_CONSTANT
SICONOS_FRICTION_3D_NSN_FORMULATION_RHO_STRATEGY_SPECTRAL_NORM
SICONOS_FRICTION_3D_NSN_FORMULATION_RHO_STRATEGY_SPLIT_SPECTRAL_NORM_COND
SICONOS_FRICTION_3D_NSN_FORMULATION_RHO_STRATEGY_SPLIT_SPECTRAL_NORM
SICONOS_FRICTION_3D_NSN_FORMULATION_RHO_STRATEGY_ADAPTIVE
SICONOS_FRICTION_3D_NSN_HYBRID_STRATEGY_NO
SICONOS_FRICTION_3D_NSN_HYBRID_STRATEGY_PLI_NSN_LOOP
SICONOS_FRICTION_3D_NSN_HYBRID_STRATEGY_NSN_AND_PLI_NSN_LOOP
SICONOS_FRICTION_3D_NSN_HYBRID_STRATEGY_VI_EG_NSN
SICONOS_FRICTION_3D_FP_ERROR_STRATEGY
SICONOS_FRICTION_3D_PROXIMAL_IPARAM_CUMULATIVE_ITER_DONE
SICONOS_FRICTION_3D_PROXIMAL_IPARAM_RELAXATION
SICONOS_FRICTION_3D_PROXIMAL_IPARAM_STRATEGY
SICONOS_FRICTION_3D_PROXIMAL_DPARAM_ALPHA
SICONOS_FRICTION_3D_PROXIMAL_PROX
SICONOS_FRICTION_3D_PROXIMAL_REGULARIZATION
SICONOS_FRICTION_3D_ADMM_IPARAM_RHO_STRATEGY
SICONOS_FRICTION_3D_ADMM_IPARAM_INITIAL_RHO
SICONOS_FRICTION_3D_ADMM_IPARAM_ACCELERATION
SICONOS_FRICTION_3D_ADMM_IPARAM_SYMMETRY
SICONOS_FRICTION_3D_ADMM_IPARAM_SPARSE_STORAGE
SICONOS_FRICTION_3D_ADMM_IPARAM_GET_PROBLEM_INFO
SICONOS_FRICTION_3D_ADMM_RHO
SICONOS_FRICTION_3D_ADMM_RESTART_ETA
SICONOS_FRICTION_3D_ADMM_BALANCING_RESIDUAL_TAU
SICONOS_FRICTION_3D_ADMM_BALANCING_RESIDUAL_PHI
SICONOS_FRICTION_3D_ADMM_RHO_STRATEGY_CONSTANT
SICONOS_FRICTION_3D_ADMM_RHO_STRATEGY_RESIDUAL_BALANCING
SICONOS_FRICTION_3D_ADMM_RHO_STRATEGY_SCALED_RESIDUAL_BALANCING
SICONOS_FRICTION_3D_ADMM_INITIAL_RHO_GIVEN
SICONOS_FRICTION_3D_ADMM_INITIAL_RHO_NORM_INF
SICONOS_FRICTION_3D_ADMM_INITIAL_RHO_EIGENVALUES
SICONOS_FRICTION_3D_IPM_IPARAM_NESTEROV_TODD_SCALING
SICONOS_FRICTION_3D_IPM_IPARAM_SPARSE_STORAGE
SICONOS_FRICTION_3D_IPM_IPARAM_GET_PROBLEM_INFO
SICONOS_FRICTION_3D_IPM_IPARAM_ITERATES_MATLAB_FILE
SICONOS_FRICTION_3D_IPM_IPARAM_REDUCED_SYSTEM
SICONOS_FRICTION_3D_IPM_IPARAM_FINISH_WITHOUT_SCALING
SICONOS_FRICTION_3D_IPM_IPARAM_UPDATE_S
SICONOS_FRICTION_3D_IPM_IPARAM_NESTEROV_TODD_SCALING_METHOD
SICONOS_FRICTION_3D_IPM_IPARAM_REDUCED_SYSTEM_METHOD
SICONOS_FRICTION_3D_IPM_IPARAM_LS_FORM
SICONOS_FRICTION_3D_IPM_IPARAM_REFINEMENT
SICONOS_FRICTION_3D_IPM_IPARAM_CHOLESKY
SICONOS_FRICTION_3D_IPM_IPARAM_ITERATES_PYTHON_FILE
SICONOS_FRICTION_3D_IPM_SIGMA_PARAMETER_1
SICONOS_FRICTION_3D_IPM_GAMMA_PARAMETER_1
SICONOS_VI_IPARAM_LINESEARCH_METHOD
SICONOS_VI_IPARAM_ERROR_EVALUATION
SICONOS_VI_IPARAM_ERROR_EVALUATION_FREQUENCY
SICONOS_VI_IPARAM_LS_MAX_ITER
SICONOS_VI_IPARAM_ACTIVATE_UPDATE
SICONOS_VI_LS_ARMIJO
SICONOS_VI_LS_SOLODOV
SICONOS_VI_LS_HANSUN
SICONOS_VI_DPARAM_RHO
SICONOS_VI_DPARAM_LS_TAU
SICONOS_VI_DPARAM_LS_TAUINV
SICONOS_VI_DPARAM_LS_L
SICONOS_VI_DPARAM_LS_LMIN
SICONOS_VI_DPARAM_SIGMA
functions_LSA
functions_LSA.compute_F
functions_LSA.compute_F_merit
functions_LSA.compute_H
functions_LSA.compute_error
functions_LSA.compute_RHS_desc
functions_LSA.compute_H_desc
functions_LSA.compute_descent_direction
functions_LSA.compute_JacTheta_merit
functions_LSA.get_set_from_problem_data
functions_LSA.ls_failure_fn
SICONOS_IPARAM_LSA_NONMONOTONE_LS
SICONOS_IPARAM_NMS_WATCHDOG_TYPE
SICONOS_DPARAM_LSA_ALPHA_MIN
SICONOS_DPARAM_NMS_DELTA
newton_LSA()
init_lsa_functions()
set_lsa_params_data()
newton_LSA_free_solverOptions()
projectionOnCone()
projectionOnDualCone()
projectionOnSecondOrderCone()
projectionOnRollingCone()
projectionOn2DRollingCone()
projectionOnDualRollingCone()
MCP
MCP_old
mixedComplementarityProblem_free()
mixedComplementarityProblem_new()
mixedComplementarityProblem_old_free()
mcp_newton_FB_FBLSA()
mcp_newton_min_FBLSA()
mcp_old_driver_init()
mcp_old_driver_reset()
mcp_old_FischerBurmeister()
mcp_old_FischerBurmeister_init()
mcp_old_FischerBurmeister_reset()
NCP
freeNCP()
newNCP()
ncp_compute_error()
ncp_newton_FBLSA()
ncp_newton_minFBLSA()
ncp_pathsearch()
ncp_path()
variationalInequality_display()
variationalInequality_printInFile()
variationalInequality_newFromFile()
freeVariationalInequalityProblem()
variationalInequality_clear()
variationalInequality_new()
newVI()
VI_get_env()
variationalInequality_ExtraGradient()
variationalInequality_FixedPointProjection()
variationalInequality_HyperplaneProjection()
variationalInequality_box_newton_QiLSA()
vi_box_AVI_LSA()
vi_get_set()
vi_box_path()
checkTrivialCase_vi()
convexQP_display()
convexQP_printInFile()
convexQP_newFromFile()
convexQP_free()
convexQP_clear()
convexQP_new()
convexQP_get_env()
convexQP_ProjectedGradient()
SICONOS_CONVEXQP_PG
SICONOS_CONVEXQP_VI_FPP
SICONOS_CONVEXQP_VI_EG
SICONOS_CONVEXQP_ADMM
SICONOS_CONVEXQP_PGOC_LINESEARCH_MAX_ITER
SICONOS_CONVEXQP_PGOC_RHO
SICONOS_CONVEXQP_PGOC_RHOMIN
SICONOS_CONVEXQP_PGOC_LINESEARCH_MU
SICONOS_CONVEXQP_PGOC_LINESEARCH_TAU
SICONOS_CONVEXQP_ADMM_IPARAM_RHO_STRATEGY
SICONOS_CONVEXQP_ADMM_IPARAM_ACCELERATION
SICONOS_CONVEXQP_ADMM_RHO
SICONOS_CONVEXQP_ADMM_RESTART_ETA
SICONOS_CONVEXQP_ADMM_BALANCING_RESIDUAL_TAU
SICONOS_CONVEXQP_ADMM_BALANCING_RESIDUAL_PHI
SICONOS_CONVEXQP_RHO_STRATEGY_CONSTANT
SICONOS_CONVEXQP_ADMM_RHO_STRATEGY_NORM_INF
SICONOS_CONVEXQP_ADMM_RHO_STRATEGY_RESIDUAL_BALANCING
SICONOS_CONVEXQP_ADMM_RHO_STRATEGY_SCALED_RESIDUAL_BALANCING
SecondOrderConeLinearComplementarityProblem
secondOrderConeLinearComplementarityProblem_display()
secondOrderConeLinearComplementarityProblem_printInFile()
secondOrderConeLinearComplementarityProblem_printInFilename()
secondOrderConeLinearComplementarityProblem_newFromFile()
secondOrderConeLinearComplementarityProblem_newFromFilename()
freeSecondOrderConeLinearComplementarityProblem()
secondOrderConeLinearComplementarityProblem_new()
soclcp_nsgs()
soclcp_VI_ExtraGradient()
soclcp_checkTrivialCase()
SICONOS_SOCLCP_NSGS
SICONOS_SOCLCP_ProjectionOnCone
SICONOS_DPARAM_SOCLCP_NSGS_RELAXATION
FrictionContactProblem
frictionContactProblem_new_with_data()
frictionContactProblem_free()
frictionContact_display()
frictionContact_printInFile()
frictionContact_printInFilename()
frictionContact_newFromFile()
frictionContact_new_from_filename()
frictionContact_copy()
frictionContact_rescaling()
fc3d_nonsmooth_Newton_AlartCurnier()
fc3d_AlartCurnierFunction()
fc3d_nonsmooth_Newton_FischerBurmeister()
fc3d_FischerBurmeisterFunction()
fc3d_nonsmooth_Newton_NaturalMap()
fc3d_NaturalMapFunction()
fc3d_nsgs()
fc3d_nsgs_velocity()
fc3d_proximal()
fc3d_TrescaFixedPoint()
fc3d_Panagiotopoulos_FixedPoint()
fc3d_ACLMFixedPoint()
fc3d_ConvexQP_ProjectedGradient_Cylinder()
fc3d_DeSaxceFixedPoint()
fc3d_fixedPointProjection()
fc3d_VI_FixedPointProjection()
fc3d_ExtraGradient()
fc3d_VI_ExtraGradient()
fc3d_HyperplaneProjection()
fc3d_AVI_gams_path()
fc3d_AVI_gams_pathvi()
fc3d_lcp_gams_path()
fc3d_lcp_gams_pathvi()
fc3d_checkTrivialCase()
fc2d_cpg()
fc2d_nsgs_dense()
fc2d_nsgs()
fc2d_projc()
fc2d_projf()
fc2d_lexicolemke()
fc2d_tolcp()
fc2d_enum()
fc3d_compute_error()
fc3d_unitary_compute_and_add_error()
fc3d_compute_error_velocity()
fc3d_Tresca_unitary_compute_and_add_error()
fc3d_Tresca_compute_error()
GAMS_opt_int
GAMS_opt_double
GAMS_opt_str
SN_GAMSparams
GlobalFrictionContactProblem
GlobalFrictionContactProblem.dimension
GlobalFrictionContactProblem.numberOfContacts
GlobalFrictionContactProblem.M
GlobalFrictionContactProblem.H
GlobalFrictionContactProblem.q
GlobalFrictionContactProblem.norm_q
GlobalFrictionContactProblem.b
GlobalFrictionContactProblem.norm_b
GlobalFrictionContactProblem.mu
GlobalFrictionContactProblem.M_inverse
GlobalFrictionContactProblem.env
globalFrictionContactProblem_new()
globalFrictionContact_display()
globalFrictionContact_printInFile()
globalFrictionContact_printInFileName()
globalFrictionContact_newFromFile()
globalFrictionContact_new_from_filename()
globalFrictionContact_free()
globalFrictionContact_computeGlobalVelocity()
globalFrictionContact_reformulation_FrictionContact()
gfc3d_checkTrivialCaseGlobal()
gfc3d_nsgs_wr()
gfc3d_proximal_wr()
gfc3d_DeSaxceFixedPoint_wr()
gfc3d_TrescaFixedPoint_wr()
gfc3d_nsgs_velocity_wr()
gfc3d_nsgs()
gfc3d_ACLMFixedPoint()
gfc3d_AVI_gams_path()
gfc3d_AVI_gams_pathvi()
gfc3d_IPM()
gfc3d_compute_error()
RollingFrictionContactProblem
rollingFrictionContactProblem_new_with_data()
rollingFrictionContactProblem_free()
rollingFrictionContact_display()
rollingFrictionContact_printInFile()
rollingFrictionContact_printInFilename()
rollingFrictionContact_newFromFile()
rollingFrictionContact_new_from_filename()
rolling_fc3d_nsgs()
rolling_fc3d_checkTrivialCase()
rolling_fc2d_nsgs()
rolling_fc2d_checkTrivialCase()
rolling_fc3d_compute_error()
rolling_fc3d_unitary_compute_and_add_error()
GlobalRollingFrictionContactProblem
GlobalRollingFrictionContactProblem.dimension
GlobalRollingFrictionContactProblem.numberOfContacts
GlobalRollingFrictionContactProblem.M
GlobalRollingFrictionContactProblem.H
GlobalRollingFrictionContactProblem.q
GlobalRollingFrictionContactProblem.b
GlobalRollingFrictionContactProblem.mu
GlobalRollingFrictionContactProblem.mu_r
globalRollingFrictionContactProblem_new_with_data()
globalRollingFrictionContactProblem_free()
globalRollingFrictionContact_display()
globalRollingFrictionContact_printInFile()
globalRollingFrictionContact_printInFilename()
globalRollingFrictionContact_newFromFile()
globalRollingFrictionContact_new_from_filename()
globalRollingFrictionContact_computeGlobalVelocity()
grfc3d_nsgs_wr()
grfc3d_IPM()
- siconos.kernel: high-level API to modelise and simulate nonsmooth dynamical systems.
MATRIX_UBLAS_TYPE
SiconosMatrix
SiconosMatrix.isBlock()
SiconosMatrix.isPLUInversed()
SiconosMatrix.isSymmetric()
SiconosMatrix.setIsSymmetric()
SiconosMatrix.isPositiveDefinite()
SiconosMatrix.setIsPositiveDefinite()
SiconosMatrix.checkSymmetry()
SiconosMatrix.isPLUFactorized()
SiconosMatrix.isPLUFactorizedInPlace()
SiconosMatrix.isCholeskyFactorized()
SiconosMatrix.isQRFactorized()
SiconosMatrix.isFactorized()
SiconosMatrix.size()
SiconosMatrix.num()
SiconosMatrix.numberOfBlocks()
SiconosMatrix.tabRow()
SiconosMatrix.tabCol()
SiconosMatrix.getDense()
SiconosMatrix.getTriang()
SiconosMatrix.getSym()
SiconosMatrix.getBanded()
SiconosMatrix.getSparse()
SiconosMatrix.getSparseCoordinate()
SiconosMatrix.getZero()
SiconosMatrix.getIdentity()
SiconosMatrix.dense()
SiconosMatrix.triang()
SiconosMatrix.sym()
SiconosMatrix.banded()
SiconosMatrix.sparse()
SiconosMatrix.sparseCoordinate()
SiconosMatrix.zero_mat()
SiconosMatrix.identity()
SiconosMatrix.getArray()
SiconosMatrix.zero()
SiconosMatrix.randomize()
SiconosMatrix.eye()
SiconosMatrix.resize()
SiconosMatrix.normInf()
SiconosMatrix.display()
SiconosMatrix.displayExpert()
SiconosMatrix.toString()
SiconosMatrix.getValue()
SiconosMatrix.setValue()
SiconosMatrix.block()
SiconosMatrix.getRow()
SiconosMatrix.getCol()
SiconosMatrix.setRow()
SiconosMatrix.setCol()
SiconosMatrix.trans()
SiconosMatrix.PLUFactorizationInPlace()
SiconosMatrix.Factorize()
SiconosMatrix.PLUInverseInPlace()
SiconosMatrix.solve_matrix()
SiconosMatrix.PLUForwardBackwardInPlace()
SiconosMatrix.solve_vector()
SiconosMatrix.resetLU()
SiconosMatrix.resetFactorizationFlags()
SiconosMatrix.nnz()
SiconosMatrix.fillCSC()
SiconosMatrix.fillTriplet()
SimpleMatrix
SimpleMatrix.isPLUInversed()
SimpleMatrix.isPLUFactorized()
SimpleMatrix.isPLUFactorizedInPlace()
SimpleMatrix.isCholeskyFactorized()
SimpleMatrix.isCholeskyFactorizedInPlace()
SimpleMatrix.isQRFactorized()
SimpleMatrix.checkSymmetry()
SimpleMatrix.getDense()
SimpleMatrix.getTriang()
SimpleMatrix.getSym()
SimpleMatrix.getBanded()
SimpleMatrix.getSparse()
SimpleMatrix.getSparseCoordinate()
SimpleMatrix.getZero()
SimpleMatrix.getIdentity()
SimpleMatrix.dense()
SimpleMatrix.triang()
SimpleMatrix.sym()
SimpleMatrix.banded()
SimpleMatrix.sparse()
SimpleMatrix.sparseCoordinate()
SimpleMatrix.zero_mat()
SimpleMatrix.identity()
SimpleMatrix.getArray()
SimpleMatrix.zero()
SimpleMatrix.randomize()
SimpleMatrix.eye()
SimpleMatrix.copyData()
SimpleMatrix.size()
SimpleMatrix.resize()
SimpleMatrix.normInf()
SimpleMatrix.normInfByColumn()
SimpleMatrix.det()
SimpleMatrix.display()
SimpleMatrix.displayExpert()
SimpleMatrix.toString()
SimpleMatrix.getValue()
SimpleMatrix.setValue()
SimpleMatrix.getRow()
SimpleMatrix.getCol()
SimpleMatrix.setRow()
SimpleMatrix.setCol()
SimpleMatrix.getSubCol()
SimpleMatrix.getSubRow()
SimpleMatrix.setSubCol()
SimpleMatrix.setSubRow()
SimpleMatrix.addBlock()
SimpleMatrix.subBlock()
SimpleMatrix.trans()
SimpleMatrix.PLUFactorizationInPlace()
SimpleMatrix.Factorize()
SimpleMatrix.PLUInverseInPlace()
SimpleMatrix.solve_matrix()
SimpleMatrix.PLUForwardBackwardInPlace()
SimpleMatrix.solve_vector()
SimpleMatrix.SolveByLeastSquares()
SimpleMatrix.resetLU()
SimpleMatrix.resetCholesky()
SimpleMatrix.resetQR()
SimpleMatrix.resetFactorizationFlags()
VECTOR_UBLAS_TYPE
SiconosVector
SiconosVector.size()
SiconosVector.num()
SiconosVector.dense()
SiconosVector.sparse()
SiconosVector.getArray()
SiconosVector.zero()
SiconosVector.resize()
SiconosVector.normInf()
SiconosVector.norm2()
SiconosVector.vector_sum()
SiconosVector.display()
SiconosVector.fill()
SiconosVector.toString()
SiconosVector.getValue()
SiconosVector.setValue()
SiconosVector.toBlock()
SiconosVector.addBlock()
SiconosVector.subBlock()
SiconosVector.copyData()
BlockVector
BlockVector.size()
BlockVector.begin()
BlockVector.end()
BlockVector.getAllVect()
BlockVector.numberOfBlocks()
BlockVector.isDense()
BlockVector.zero()
BlockVector.fill()
BlockVector.display()
BlockVector.toString()
BlockVector.getValue()
BlockVector.setValue()
BlockVector.vector()
BlockVector.setVector()
BlockVector.setVectorPtr()
BlockVector.setAllVect()
BlockVector.tabIndex()
BlockVector.getNumVectorAtPos()
BlockVector.insertPtr()
BlockVector.norm2()
BlockVector.normInf()
BlockVector.prepareVectorForPlugin()
Callback
SolverOptions
SolverOptions.solverId
SolverOptions.isSet
SolverOptions.iSize
SolverOptions.iparam
SolverOptions.dSize
SolverOptions.dparam
SolverOptions.filterOn
SolverOptions.dWorkSize
SolverOptions.dWork
SolverOptions.iWorkSize
SolverOptions.iWork
SolverOptions.numberOfInternalSolvers
SolverOptions.internalSolvers
SolverOptions.callback
SolverOptions.solverParameters
SolverOptions.solverData
SICONOS_ERROR_FULL_EVALUATION
SICONOS_ERROR_LIGHT_EVALUATION
SICONOS_ERROR_LIGHT_EVALUATION_NO_UPDATE
solver_options_print()
solver_options_delete()
solver_options_create()
solver_options_copy()
solver_options_update_internal()
solver_options_name_to_id()
solver_options_id_to_name()
solver_options_get_internal_solver()
solver_options_set_internal_solver()
ioMatrix_read()
ioMatrix_write()
compareRefFile()
TD_EVENT
DENSE
TRIANGULAR
SYMMETRIC
SPARSE
BANDED
ZERO
IDENTITY
SPARSE_COORDINATE
NonSmoothLaw
NewtonImpactNSL
NewtonImpactFrictionNSL
FremondImpactFrictionNSL
NewtonImpactRollingFrictionNSL
NewtonImpactRollingFrictionNSL.isVerified()
NewtonImpactRollingFrictionNSL.en()
NewtonImpactRollingFrictionNSL.setEn()
NewtonImpactRollingFrictionNSL.et()
NewtonImpactRollingFrictionNSL.setEt()
NewtonImpactRollingFrictionNSL.mu()
NewtonImpactRollingFrictionNSL.muR()
NewtonImpactRollingFrictionNSL.setMu()
NewtonImpactRollingFrictionNSL.setMuR()
NewtonImpactRollingFrictionNSL.display()
MixedComplementarityConditionNSL
ComplementarityConditionNSL
EqualityConditionNSL
MultipleImpactNSL
RelayNSL
NormalConeNSL
DynamicalSystem
DynamicalSystem.initRhs()
DynamicalSystem.initializeNonSmoothInput()
DynamicalSystem.update()
DynamicalSystem.computeRhs()
DynamicalSystem.computeJacobianRhsx()
DynamicalSystem.resetAllNonSmoothParts()
DynamicalSystem.resetNonSmoothPart()
DynamicalSystem.number()
DynamicalSystem.setNumber()
DynamicalSystem.n()
DynamicalSystem.dimension()
DynamicalSystem.x0()
DynamicalSystem.getX0()
DynamicalSystem.setX0()
DynamicalSystem.setX0Ptr()
DynamicalSystem.x()
DynamicalSystem.getx()
DynamicalSystem.setX()
DynamicalSystem.setXPtr()
DynamicalSystem.r()
DynamicalSystem.getR()
DynamicalSystem.setR()
DynamicalSystem.setRPtr()
DynamicalSystem.rhs()
DynamicalSystem.getRhs()
DynamicalSystem.setRhs()
DynamicalSystem.setRhsPtr()
DynamicalSystem.jacobianRhsx()
DynamicalSystem.setJacobianRhsx()
DynamicalSystem.setJacobianRhsxPtr()
DynamicalSystem.z()
DynamicalSystem.getz()
DynamicalSystem.setz()
DynamicalSystem.setzPtr()
DynamicalSystem.xMemory()
DynamicalSystem.stepsInMemory()
DynamicalSystem.setStepsInMemory()
DynamicalSystem.initMemory()
DynamicalSystem.swapInMemory()
DynamicalSystem.updatePlugins()
DynamicalSystem.resetCount()
DynamicalSystem.resetToInitialState()
DynamicalSystem.isLinear()
DynamicalSystem.display()
NonSmoothDynamicalSystem
NonSmoothDynamicalSystem.currentTime()
NonSmoothDynamicalSystem.setCurrentTime()
NonSmoothDynamicalSystem.t0()
NonSmoothDynamicalSystem.sett0()
NonSmoothDynamicalSystem.finalT()
NonSmoothDynamicalSystem.setT()
NonSmoothDynamicalSystem.title()
NonSmoothDynamicalSystem.setTitle()
NonSmoothDynamicalSystem.author()
NonSmoothDynamicalSystem.setAuthor()
NonSmoothDynamicalSystem.description()
NonSmoothDynamicalSystem.setDescription()
NonSmoothDynamicalSystem.date()
NonSmoothDynamicalSystem.setDate()
NonSmoothDynamicalSystem.isBVP()
NonSmoothDynamicalSystem.isIVP()
NonSmoothDynamicalSystem.setBVP()
NonSmoothDynamicalSystem.changeLog()
NonSmoothDynamicalSystem.changeLogPosition()
NonSmoothDynamicalSystem.changeLogBegin()
NonSmoothDynamicalSystem.clearChangeLogTo()
NonSmoothDynamicalSystem.getNumberOfDS()
NonSmoothDynamicalSystem.dynamicalSystems()
NonSmoothDynamicalSystem.dynamicalSystemsVector()
NonSmoothDynamicalSystem.insertDynamicalSystem()
NonSmoothDynamicalSystem.dynamicalSystem()
NonSmoothDynamicalSystem.removeDynamicalSystem()
NonSmoothDynamicalSystem.getNumberOfInteractions()
NonSmoothDynamicalSystem.interactions()
NonSmoothDynamicalSystem.removeInteraction()
NonSmoothDynamicalSystem.interaction()
NonSmoothDynamicalSystem.InteractionsVector()
NonSmoothDynamicalSystem.link()
NonSmoothDynamicalSystem.setName()
NonSmoothDynamicalSystem.name()
NonSmoothDynamicalSystem.setControlProperty()
NonSmoothDynamicalSystem.topology()
NonSmoothDynamicalSystem.display()
NonSmoothDynamicalSystem.isLinear()
NonSmoothDynamicalSystem.setSymmetric()
NonSmoothDynamicalSystem.resetNonSmoothPart()
NonSmoothDynamicalSystem.swapInMemory()
NonSmoothDynamicalSystem.pushInteractionsInMemory()
NonSmoothDynamicalSystem.updateDSPlugins()
NonSmoothDynamicalSystem.updateInput()
NonSmoothDynamicalSystem.updateOutput()
NonSmoothDynamicalSystem.computeInteractionJacobians()
NonSmoothDynamicalSystem.visitDynamicalSystems()
LinearComplementaritySystemsNSDS
Topology
Topology.hasDynamicalSystem()
Topology.hasInteraction()
Topology.removeInteraction()
Topology.insertDynamicalSystem()
Topology.removeDynamicalSystem()
Topology.setName()
Topology.name()
Topology.setOSI()
Topology.link()
Topology.setControlProperty()
Topology.indexSet0()
Topology.indexSet()
Topology.numberOfIndexSet()
Topology.resetIndexSetPtr()
Topology.dSG()
Topology.indexSetsSize()
Topology.indexSetSize()
Topology.indexSetsResize()
Topology.setHasChanged()
Topology.hasChanged()
Topology.numberOfConstraints()
Topology.setSymmetric()
Topology.setProperties()
Topology.displayDynamicalSystems()
Topology.getDynamicalSystem()
Topology.getInteraction()
Topology.interactionsForDS()
Topology.interactionsForPairOfDS()
Topology.dynamicalSystemsForInteraction()
Topology.getDSG0Descriptor()
Topology.numberOfInvolvedDS()
SecondOrderDS
SecondOrderDS.p()
SecondOrderDS.mass()
SecondOrderDS.inverseMass()
SecondOrderDS.setMassPtr()
SecondOrderDS.setRhs()
SecondOrderDS.setRhsPtr()
SecondOrderDS.computeForces()
SecondOrderDS.computeJacobianqForces()
SecondOrderDS.computeJacobianvForces()
SecondOrderDS.dimension()
SecondOrderDS.q()
SecondOrderDS.setQ()
SecondOrderDS.setQPtr()
SecondOrderDS.q0()
SecondOrderDS.setQ0()
SecondOrderDS.setQ0Ptr()
SecondOrderDS.velocity()
SecondOrderDS.setVelocity()
SecondOrderDS.setVelocityPtr()
SecondOrderDS.velocity0()
SecondOrderDS.setVelocity0()
SecondOrderDS.setVelocity0Ptr()
SecondOrderDS.acceleration()
SecondOrderDS.forces()
SecondOrderDS.jacobianqForces()
SecondOrderDS.jacobianvForces()
SecondOrderDS.qMemory()
SecondOrderDS.velocityMemory()
SecondOrderDS.forcesMemory()
SecondOrderDS.initMemory()
SecondOrderDS.computeMass()
SecondOrderDS.setBoundaryConditions()
SecondOrderDS.boundaryConditions()
SecondOrderDS.setReactionToBoundaryConditions()
SecondOrderDS.reactionToBoundaryConditions()
SecondOrderDS.init_inverse_mass()
SecondOrderDS.update_inverse_mass()
SecondOrderDS.init_forces()
LagrangianDS
LagrangianDS.resetToInitialState()
LagrangianDS.initRhs()
LagrangianDS.initializeNonSmoothInput()
LagrangianDS.computeRhs()
LagrangianDS.computeJacobianRhsx()
LagrangianDS.resetAllNonSmoothParts()
LagrangianDS.resetNonSmoothPart()
LagrangianDS.setRhs()
LagrangianDS.setRhsPtr()
LagrangianDS.computeForces()
LagrangianDS.computeJacobianqForces()
LagrangianDS.computeJacobianqDotForces()
LagrangianDS.computeJacobianvForces()
LagrangianDS.q()
LagrangianDS.setQ()
LagrangianDS.setQPtr()
LagrangianDS.setQ0()
LagrangianDS.setQ0Ptr()
LagrangianDS.velocity()
LagrangianDS.setVelocity()
LagrangianDS.setVelocityPtr()
LagrangianDS.velocity0()
LagrangianDS.setVelocity0()
LagrangianDS.setVelocity0Ptr()
LagrangianDS.acceleration()
LagrangianDS.fInt()
LagrangianDS.setFIntPtr()
LagrangianDS.fExt()
LagrangianDS.setFExtPtr()
LagrangianDS.fGyr()
LagrangianDS.setFGyrPtr()
LagrangianDS.jacobianFIntq()
LagrangianDS.jacobianFIntqDot()
LagrangianDS.setJacobianFIntqPtr()
LagrangianDS.setJacobianFIntqDotPtr()
LagrangianDS.jacobianFGyrq()
LagrangianDS.jacobianFGyrqDot()
LagrangianDS.setJacobianFGyrqPtr()
LagrangianDS.setJacobianFGyrqDotPtr()
LagrangianDS.forces()
LagrangianDS.jacobianqForces()
LagrangianDS.jacobianvForces()
LagrangianDS.qMemory()
LagrangianDS.velocityMemory()
LagrangianDS.pMemory()
LagrangianDS.forcesMemory()
LagrangianDS.initMemory()
LagrangianDS.swapInMemory()
LagrangianDS.setComputeMassFunction()
LagrangianDS.setComputeFIntFunction()
LagrangianDS.setComputeFExtFunction()
LagrangianDS.setComputeFGyrFunction()
LagrangianDS.setComputeJacobianFIntqFunction()
LagrangianDS.setComputeJacobianFIntqDotFunction()
LagrangianDS.setComputeJacobianFGyrqFunction()
LagrangianDS.setComputeJacobianFGyrqDotFunction()
LagrangianDS.computeMass()
LagrangianDS.computeFInt()
LagrangianDS.computeFExt()
LagrangianDS.computeFGyr()
LagrangianDS.computeJacobianFIntq()
LagrangianDS.computeJacobianFIntqDot()
LagrangianDS.computeJacobianFGyrq()
LagrangianDS.computeJacobianFGyrqDot()
LagrangianDS.updatePlugins()
LagrangianDS.computeKineticEnergy()
LagrangianDS.display()
LagrangianDS.computePostImpactVelocity()
LagrangianDS.init_generalized_coordinates()
LagrangianDS.init_inverse_mass()
LagrangianDS.update_inverse_mass()
LagrangianDS.init_forces()
LagrangianLinearTIDS
LagrangianLinearTIDS.initRhs()
LagrangianLinearTIDS.computeForces()
LagrangianLinearTIDS.getK()
LagrangianLinearTIDS.K()
LagrangianLinearTIDS.setK()
LagrangianLinearTIDS.setKPtr()
LagrangianLinearTIDS.getC()
LagrangianLinearTIDS.C()
LagrangianLinearTIDS.setC()
LagrangianLinearTIDS.setCPtr()
LagrangianLinearTIDS.jacobianqForces()
LagrangianLinearTIDS.jacobianvForces()
LagrangianLinearTIDS.isLinear()
LagrangianLinearTIDS.display()
LagrangianLinearDiagonalDS
LagrangianLinearDiagonalDS.get_stiffness()
LagrangianLinearDiagonalDS.stiffness()
LagrangianLinearDiagonalDS.get_damping()
LagrangianLinearDiagonalDS.damping()
LagrangianLinearDiagonalDS.initRhs()
LagrangianLinearDiagonalDS.computeForces()
LagrangianLinearDiagonalDS.isLinear()
LagrangianLinearDiagonalDS.display()
computeExtForceAtPos()
NewtonEulerDS
NewtonEulerDS.resetToInitialState()
NewtonEulerDS.initRhs()
NewtonEulerDS.initializeNonSmoothInput()
NewtonEulerDS.computeRhs()
NewtonEulerDS.computeJacobianRhsx()
NewtonEulerDS.resetAllNonSmoothParts()
NewtonEulerDS.resetNonSmoothPart()
NewtonEulerDS.forces()
NewtonEulerDS.jacobianqForces()
NewtonEulerDS.jacobianvForces()
NewtonEulerDS.getqDim()
NewtonEulerDS.q()
NewtonEulerDS.setQ()
NewtonEulerDS.setQPtr()
NewtonEulerDS.setQ0()
NewtonEulerDS.setQ0Ptr()
NewtonEulerDS.twist()
NewtonEulerDS.velocity()
NewtonEulerDS.velocity0()
NewtonEulerDS.setVelocity()
NewtonEulerDS.setVelocityPtr()
NewtonEulerDS.setVelocity0()
NewtonEulerDS.setVelocity0Ptr()
NewtonEulerDS.acceleration()
NewtonEulerDS.computeMass()
NewtonEulerDS.linearVelocity()
NewtonEulerDS.angularVelocity()
NewtonEulerDS.scalarMass()
NewtonEulerDS.setScalarMass()
NewtonEulerDS.inertia()
NewtonEulerDS.setInertia()
NewtonEulerDS.updateMassMatrix()
NewtonEulerDS.fExt()
NewtonEulerDS.setFExtPtr()
NewtonEulerDS.mExt()
NewtonEulerDS.setMExtPtr()
NewtonEulerDS.mGyr()
NewtonEulerDS.qMemory()
NewtonEulerDS.twistMemory()
NewtonEulerDS.velocityMemory()
NewtonEulerDS.initMemory()
NewtonEulerDS.swapInMemory()
NewtonEulerDS.forcesMemory()
NewtonEulerDS.computeKineticEnergy()
NewtonEulerDS.display()
NewtonEulerDS.init_inverse_mass()
NewtonEulerDS.update_inverse_mass()
NewtonEulerDS.setComputeFExtFunction()
NewtonEulerDS.setComputeMExtFunction()
NewtonEulerDS.setComputeFIntFunction()
NewtonEulerDS.setComputeMIntFunction()
NewtonEulerDS.setComputeJacobianFIntqFunction()
NewtonEulerDS.setComputeJacobianFIntvFunction()
NewtonEulerDS.setComputeJacobianMIntqFunction()
NewtonEulerDS.setComputeJacobianMIntvFunction()
NewtonEulerDS.computeFExt()
NewtonEulerDS.addExtForceAtPos()
NewtonEulerDS.computeFInt()
NewtonEulerDS.computeMInt()
NewtonEulerDS.updatePlugins()
NewtonEulerDS.init_forces()
NewtonEulerDS.computeForces()
NewtonEulerDS.computeJacobianqForces()
NewtonEulerDS.computeJacobianvForces()
NewtonEulerDS.computeMGyr()
NewtonEulerDS.computeJacobianMGyrtwist()
NewtonEulerDS.computeJacobianMGyrtwistByFD()
NewtonEulerDS.computeJacobianFIntq()
NewtonEulerDS.computeJacobianFIntqByFD()
NewtonEulerDS.computeJacobianFIntv()
NewtonEulerDS.computeJacobianFIntvByFD()
NewtonEulerDS.computeJacobianMIntq()
NewtonEulerDS.computeJacobianMIntqByFD()
NewtonEulerDS.computeJacobianMIntv()
NewtonEulerDS.computeJacobianMIntvByFD()
FirstOrderNonLinearDS
FirstOrderNonLinearDS.initRhs()
FirstOrderNonLinearDS.initializeNonSmoothInput()
FirstOrderNonLinearDS.resetToInitialState()
FirstOrderNonLinearDS.computeRhs()
FirstOrderNonLinearDS.computeJacobianRhsx()
FirstOrderNonLinearDS.resetAllNonSmoothParts()
FirstOrderNonLinearDS.resetNonSmoothPart()
FirstOrderNonLinearDS.M()
FirstOrderNonLinearDS.setMPtr()
FirstOrderNonLinearDS.getInvM()
FirstOrderNonLinearDS.invM()
FirstOrderNonLinearDS.f()
FirstOrderNonLinearDS.setFPtr()
FirstOrderNonLinearDS.jacobianfx()
FirstOrderNonLinearDS.setJacobianfxPtr()
FirstOrderNonLinearDS.rMemory()
FirstOrderNonLinearDS.fold()
FirstOrderNonLinearDS.initMemory()
FirstOrderNonLinearDS.swapInMemory()
FirstOrderNonLinearDS.updatePlugins()
FirstOrderNonLinearDS.setComputeMFunction()
FirstOrderNonLinearDS.setComputeFFunction()
FirstOrderNonLinearDS.setComputeJacobianfxFunction()
FirstOrderNonLinearDS.computeM()
FirstOrderNonLinearDS.computef()
FirstOrderNonLinearDS.computeJacobianfx()
FirstOrderNonLinearDS.getPluginF()
FirstOrderNonLinearDS.getPluginJacxf()
FirstOrderNonLinearDS.getPluginM()
FirstOrderNonLinearDS.display()
FirstOrderLinearDS
FirstOrderLinearDS.initRhs()
FirstOrderLinearDS.computeRhs()
FirstOrderLinearDS.computeJacobianRhsx()
FirstOrderLinearDS.A()
FirstOrderLinearDS.jacobianfx()
FirstOrderLinearDS.setAPtr()
FirstOrderLinearDS.setA()
FirstOrderLinearDS.b()
FirstOrderLinearDS.setbPtr()
FirstOrderLinearDS.setb()
FirstOrderLinearDS.updatePlugins()
FirstOrderLinearDS.setComputeAFunction()
FirstOrderLinearDS.setComputebFunction()
FirstOrderLinearDS.computeA()
FirstOrderLinearDS.computeb()
FirstOrderLinearDS.getPluginA()
FirstOrderLinearDS.getPluginB()
FirstOrderLinearDS.setPluginA()
FirstOrderLinearDS.setPluginB()
FirstOrderLinearDS.display()
FirstOrderLinearDS.isLinear()
FirstOrderLinearTIDS
Relation
Relation.getType()
Relation.getSubType()
Relation.setComputehFunction()
Relation.setComputeJachxFunction()
Relation.setComputeJachzFunction()
Relation.setComputeJachlambdaFunction()
Relation.setComputegFunction()
Relation.setComputeFFunction()
Relation.setComputeEFunction()
Relation.setComputeJacgxFunction()
Relation.setComputeJacglambdaFunction()
Relation.initialize()
Relation.checkSize()
Relation.computeJach()
Relation.computeJacg()
Relation.computeOutput()
Relation.computeInput()
Relation.isLinear()
Relation.requireResidu()
Relation.display()
Relation.getPluginh()
Relation.getPluginJachx()
Relation.getPluginJachlambda()
Relation.getPluging()
Relation.getPluginJacLg()
Relation.getPluginf()
Relation.getPlugine()
LagrangianR
LagrangianLinearTIR
LagrangianLinearTIR.checkSize()
LagrangianLinearTIR.computeOutput()
LagrangianLinearTIR.computeInput()
LagrangianLinearTIR.computeJach()
LagrangianLinearTIR.computeJacg()
LagrangianLinearTIR.C()
LagrangianLinearTIR.setCPtr()
LagrangianLinearTIR.D()
LagrangianLinearTIR.setDPtr()
LagrangianLinearTIR.F()
LagrangianLinearTIR.setFPtr()
LagrangianLinearTIR.e()
LagrangianLinearTIR.setEPtr()
LagrangianLinearTIR.display()
LagrangianLinearTIR.isLinear()
LagrangianRheonomousR
LagrangianRheonomousR.initialize()
LagrangianRheonomousR.checkSize()
LagrangianRheonomousR.hDot()
LagrangianRheonomousR.setComputehDotFunction()
LagrangianRheonomousR.computeh()
LagrangianRheonomousR.computehDot()
LagrangianRheonomousR.computeJachq()
LagrangianRheonomousR.computeJach()
LagrangianRheonomousR.computeJacg()
LagrangianRheonomousR.computeOutput()
LagrangianRheonomousR.computeInput()
LagrangianScleronomousR
LagrangianScleronomousR.initialize()
LagrangianScleronomousR.checkSize()
LagrangianScleronomousR.dotjacqhXqdot()
LagrangianScleronomousR.computeh()
LagrangianScleronomousR.computeJachq()
LagrangianScleronomousR.computeDotJachq()
LagrangianScleronomousR.computedotjacqhXqdot()
LagrangianScleronomousR.computeJach()
LagrangianScleronomousR.computeJacg()
LagrangianScleronomousR.computeOutput()
LagrangianScleronomousR.computeInput()
LagrangianCompliantR
LagrangianCompliantR.initialize()
LagrangianCompliantR.checkSize()
LagrangianCompliantR.computeh()
LagrangianCompliantR.computeJachq()
LagrangianCompliantR.computeJachlambda()
LagrangianCompliantR.computeOutput()
LagrangianCompliantR.computeInput()
LagrangianCompliantR.computeJach()
LagrangianCompliantR.computeJacg()
NewtonEulerR
NewtonEulerR.jachq()
NewtonEulerR.setJachqPtr()
NewtonEulerR.initialize()
NewtonEulerR.checkSize()
NewtonEulerR.computeh()
NewtonEulerR.computeJachlambda()
NewtonEulerR.computeJachq()
NewtonEulerR.computeJachqDot()
NewtonEulerR.computeJacglambda()
NewtonEulerR.computeJacgq()
NewtonEulerR.computeJacgqDot()
NewtonEulerR.computeJachqT()
NewtonEulerR.computeJach()
NewtonEulerR.computeJacg()
NewtonEulerR.computeSecondOrderTimeDerivativeTerms()
NewtonEulerR.computeOutput()
NewtonEulerR.computeInput()
NewtonEulerR.C()
NewtonEulerR.D()
NewtonEulerR.B()
NewtonEulerR.contactForce()
NewtonEulerR.display()
NewtonEuler1DR
NewtonEuler1DR.setpc1()
NewtonEuler1DR.setpc2()
NewtonEuler1DR.setnc()
NewtonEuler1DR.computeJachq()
NewtonEuler1DR.initialize()
NewtonEuler1DR.computeJachqT()
NewtonEuler1DR.computeh()
NewtonEuler1DR.computehFromRelativeContactPoints()
NewtonEuler1DR.distance()
NewtonEuler1DR.setRelPc1()
NewtonEuler1DR.setRelPc2()
NewtonEuler1DR.setRelNc()
NewtonEuler1DR.display()
NewtonEuler3DR
NewtonEuler5DR
FirstOrderR
FirstOrderNonLinearR
FirstOrderNonLinearR.initialize()
FirstOrderNonLinearR.checkSize()
FirstOrderNonLinearR.computeh()
FirstOrderNonLinearR.computeg()
FirstOrderNonLinearR.computeJachx()
FirstOrderNonLinearR.computeJachlambda()
FirstOrderNonLinearR.computeJach()
FirstOrderNonLinearR.computeJacglambda()
FirstOrderNonLinearR.computeJacgx()
FirstOrderNonLinearR.computeJacg()
FirstOrderNonLinearR.computeOutput()
FirstOrderNonLinearR.computeInput()
FirstOrderNonLinearR.requireResidu()
FirstOrderType1R
FirstOrderType1R.initialize()
FirstOrderType1R.checkSize()
FirstOrderType1R.computeh()
FirstOrderType1R.computeg()
FirstOrderType1R.computeJachx()
FirstOrderType1R.computeJachz()
FirstOrderType1R.computeJacglambda()
FirstOrderType1R.computeOutput()
FirstOrderType1R.computeInput()
FirstOrderType1R.computeJach()
FirstOrderType1R.computeJacg()
FirstOrderType1R.requireResidu()
FirstOrderType2R
FirstOrderType2R.initialize()
FirstOrderType2R.checkSize()
FirstOrderType2R.computeh()
FirstOrderType2R.computeg()
FirstOrderType2R.computeJachx()
FirstOrderType2R.computeJacglambda()
FirstOrderType2R.computeJachlambda()
FirstOrderType2R.computeOutput()
FirstOrderType2R.computeInput()
FirstOrderType2R.requireResidu()
FirstOrderType2R.computeJach()
FirstOrderType2R.computeJacg()
FirstOrderLinearR
FirstOrderLinearR.initialize()
FirstOrderLinearR.checkSize()
FirstOrderLinearR.setComputeCFunction()
FirstOrderLinearR.setComputeDFunction()
FirstOrderLinearR.setComputeBFunction()
FirstOrderLinearR.computeC()
FirstOrderLinearR.computeD()
FirstOrderLinearR.computeF()
FirstOrderLinearR.computee()
FirstOrderLinearR.computeB()
FirstOrderLinearR.computeh()
FirstOrderLinearR.computeg()
FirstOrderLinearR.computeOutput()
FirstOrderLinearR.computeInput()
FirstOrderLinearR.display()
FirstOrderLinearR.setePtr()
FirstOrderLinearR.e()
FirstOrderLinearR.isLinear()
FirstOrderLinearR.computeJach()
FirstOrderLinearR.computeJacg()
FirstOrderLinearTIR
FirstOrderLinearTIR.initialize()
FirstOrderLinearTIR.checkSize()
FirstOrderLinearTIR.computeh()
FirstOrderLinearTIR.computeg()
FirstOrderLinearTIR.computeOutput()
FirstOrderLinearTIR.computeInput()
FirstOrderLinearTIR.display()
FirstOrderLinearTIR.setePtr()
FirstOrderLinearTIR.e()
FirstOrderLinearTIR.isLinear()
FirstOrderLinearTIR.computeJach()
FirstOrderLinearTIR.computeJacg()
Interaction
Interaction.reset()
Interaction.initializeLinkToDsVariables()
Interaction.resetAllLambda()
Interaction.resetLambda()
Interaction.initializeMemory()
Interaction.number()
Interaction.setLowerLevelForOutput()
Interaction.setUpperLevelForOutput()
Interaction.lowerLevelForOutput()
Interaction.upperLevelForOutput()
Interaction.setLowerLevelForInput()
Interaction.setUpperLevelForInput()
Interaction.lowerLevelForInput()
Interaction.upperLevelForInput()
Interaction.dimension()
Interaction.getSizeOfDS()
Interaction.setHas2Bodies()
Interaction.has2Bodies()
Interaction.getCopyOfy()
Interaction.y()
Interaction.setY()
Interaction.setYPtr()
Interaction.yMemory()
Interaction.y_k()
Interaction.getLambda()
Interaction.lambda_()
Interaction.lambdaMemory()
Interaction.lambda_k()
Interaction.setLambda()
Interaction.setLambdaPtr()
Interaction.relation()
Interaction.nonSmoothLaw()
Interaction.setDSSizes()
Interaction.swapInMemory()
Interaction.display()
Interaction.resetCount()
Interaction.computeOutput()
Interaction.computeInput()
Interaction.getLeftInteractionBlock()
Interaction.getLeftInteractionBlockForDS()
Interaction.getLeftInteractionBlockForDSProjectOnConstraints()
Interaction.getRightInteractionBlockForDS()
Interaction.getExtraInteractionBlock()
TimeDiscretisation
OneStepNSProblem
OneStepNSProblem.numericsSolverOptions()
OneStepNSProblem.getSizeOutput()
OneStepNSProblem.simulation()
OneStepNSProblem.setSimulationPtr()
OneStepNSProblem.indexSetLevel()
OneStepNSProblem.setIndexSetLevel()
OneStepNSProblem.inputOutputLevel()
OneStepNSProblem.setInputOutputLevel()
OneStepNSProblem.maxSize()
OneStepNSProblem.setMaxSize()
OneStepNSProblem.setNumericsVerboseMode()
OneStepNSProblem.setNumericsVerboseLevel()
OneStepNSProblem.hasInteractions()
OneStepNSProblem.displayBlocks()
OneStepNSProblem.updateInteractionBlocks()
OneStepNSProblem.computeInteractionBlock()
OneStepNSProblem.computeDiagonalInteractionBlock()
OneStepNSProblem.hasBeenUpdated()
OneStepNSProblem.setHasBeenUpdated()
OneStepNSProblem.initialize()
OneStepNSProblem.preCompute()
OneStepNSProblem.compute()
OneStepNSProblem.postCompute()
OneStepNSProblem.setSolverId()
OneStepNSProblem.getOSIMatrix()
OneStepIntegrator
OneStepIntegrator.getType()
OneStepIntegrator.dynamicalSystemsGraph()
OneStepIntegrator.setDynamicalSystemsGraph()
OneStepIntegrator.getSizeMem()
OneStepIntegrator.simulation()
OneStepIntegrator.setSimulationPtr()
OneStepIntegrator.levelMinForOutput()
OneStepIntegrator.levelMaxForOutput()
OneStepIntegrator.levelMinForInput()
OneStepIntegrator.levelMaxForInput()
OneStepIntegrator.numberOfIndexSets()
OneStepIntegrator.initialize()
OneStepIntegrator.initialize_nonsmooth_problems()
OneStepIntegrator.initializeWorkVectorsForDS()
OneStepIntegrator.initializeWorkVectorsForInteraction()
OneStepIntegrator.UpdateAndSwapAllOutput()
OneStepIntegrator.computeInitialNewtonState()
OneStepIntegrator.computeResidu()
OneStepIntegrator.computeFreeState()
OneStepIntegrator.computeFreeOutput()
OneStepIntegrator.computeResiduOutput()
OneStepIntegrator.computeResiduInput()
OneStepIntegrator.integrate()
OneStepIntegrator.resetAllNonSmoothParts()
OneStepIntegrator.resetNonSmoothPart()
OneStepIntegrator.updateState()
OneStepIntegrator.updateOutput()
OneStepIntegrator.updateInput()
OneStepIntegrator.display()
OneStepIntegrator.addInteractionInIndexSet()
OneStepIntegrator.removeInteractionFromIndexSet()
OneStepIntegrator.extraAdditionalTerms()
OneStepIntegrator.setExtraAdditionalTerms()
OneStepIntegrator.checkOSI()
OneStepIntegrator.checkInteractionOSI()
LinearOSNS
LinearOSNS.getW()
LinearOSNS.w()
LinearOSNS.setWPtr()
LinearOSNS.getz()
LinearOSNS.z()
LinearOSNS.setzPtr()
LinearOSNS.M()
LinearOSNS.setMPtr()
LinearOSNS.H()
LinearOSNS.setH()
LinearOSNS.getQ()
LinearOSNS.q()
LinearOSNS.setQPtr()
LinearOSNS.getMStorageType()
LinearOSNS.setMStorageType()
LinearOSNS.setAssemblyType()
LinearOSNS.initVectorsMemory()
LinearOSNS.initOSNSMatrix()
LinearOSNS.initialize()
LinearOSNS.computeInteractionBlock()
LinearOSNS.computeDiagonalInteractionBlock()
LinearOSNS.computeM()
LinearOSNS.computeqBlock()
LinearOSNS.computeq()
LinearOSNS.preCompute()
LinearOSNS.postCompute()
LinearOSNS.display()
LinearOSNS.setKeepLambdaAndYState()
LsodarOSI
LsodarOSI.count_NST
LsodarOSI.count_NFE
LsodarOSI.intData()
LsodarOSI.setIntData()
LsodarOSI.getRtol()
LsodarOSI.getAtol()
LsodarOSI.getMaxNstep()
LsodarOSI.getRwork()
LsodarOSI.getIwork()
LsodarOSI.getJroot()
LsodarOSI.setJT()
LsodarOSI.setTol()
LsodarOSI.setMaxNstep()
LsodarOSI.setMinMaxStepSizes()
LsodarOSI.setMaxOrder()
LsodarOSI.updateData()
LsodarOSI.fillXWork()
LsodarOSI.computeRhs()
LsodarOSI.computeJacobianRhs()
LsodarOSI.initialize()
LsodarOSI.initializeWorkVectorsForDS()
LsodarOSI.initializeWorkVectorsForInteraction()
LsodarOSI.numberOfIndexSets()
LsodarOSI.integrate()
LsodarOSI.updateState()
LsodarOSI.computeFreeOutput()
LsodarOSI.display()
LsodarOSI.count_rhs_call()
LsodarOSI.count_steps()
LCP
AVI
QP
Relay
MLCP
MLCPProjectOnConstraints
MLCPProjectOnConstraints.computeOptions()
MLCPProjectOnConstraints.alpha()
MLCPProjectOnConstraints.setAlpha()
MLCPProjectOnConstraints.displayBlocks()
MLCPProjectOnConstraints.display()
MLCPProjectOnConstraints.initOSNSMatrix()
MLCPProjectOnConstraints.updateInteractionBlocks()
MLCPProjectOnConstraints.updateInteractionBlocksOLD()
MLCPProjectOnConstraints.computeDiagonalInteractionBlock()
MLCPProjectOnConstraints.computeInteractionBlock()
MLCPProjectOnConstraints.computeqBlock()
MLCPProjectOnConstraints.computeq()
MLCPProjectOnConstraints.postCompute()
MLCPProjectOnConstraints.postComputeLagrangianR()
MLCPProjectOnConstraints.postComputeNewtonEulerR()
GenericMechanical
FrictionContact
FrictionContact.getFrictionContactDim()
FrictionContact.mu()
FrictionContact.getMu()
FrictionContact.updateMu()
FrictionContact.setNumericsDriver()
FrictionContact.initialize()
FrictionContact.frictionContactProblem()
FrictionContact.frictionContactProblemPtr()
FrictionContact.solve()
FrictionContact.compute()
FrictionContact.display()
GlobalFrictionContact
GlobalFrictionContact.getGlobalFrictionContactDim()
GlobalFrictionContact.getGlobalSizeOutput()
GlobalFrictionContact.globalVelocities()
GlobalFrictionContact.setGlobalVelocities()
GlobalFrictionContact.mu()
GlobalFrictionContact.getMu()
GlobalFrictionContact.initVectorsMemory()
GlobalFrictionContact.initialize()
GlobalFrictionContact.globalFrictionContactProblem()
GlobalFrictionContact.globalFrictionContactProblemPtr()
GlobalFrictionContact.solve()
GlobalFrictionContact.preCompute()
GlobalFrictionContact.compute()
GlobalFrictionContact.postCompute()
GlobalFrictionContact.display()
RollingFrictionContact
RollingFrictionContact.getRollingFrictionContactDim()
RollingFrictionContact.mu()
RollingFrictionContact.getMu()
RollingFrictionContact.updateMu()
RollingFrictionContact.setNumericsDriver()
RollingFrictionContact.initialize()
RollingFrictionContact.frictionContactProblem()
RollingFrictionContact.frictionContactProblemPtr()
RollingFrictionContact.solve()
RollingFrictionContact.compute()
RollingFrictionContact.display()
RollingFrictionContact.checkCompatibleNSLaw()
GlobalRollingFrictionContact
GlobalRollingFrictionContact.getGlobalRollingFrictionContactDim()
GlobalRollingFrictionContact.getGlobalSizeOutput()
GlobalRollingFrictionContact.mur()
GlobalRollingFrictionContact.getMur()
GlobalRollingFrictionContact.initialize()
GlobalRollingFrictionContact.globalRollingFrictionContactProblem()
GlobalRollingFrictionContact.globalRollingFrictionContactProblemPtr()
GlobalRollingFrictionContact.solve()
GlobalRollingFrictionContact.preCompute()
GlobalRollingFrictionContact.compute()
GlobalRollingFrictionContact.display()
EulerMoreauOSI
EulerMoreauOSI.getW()
EulerMoreauOSI.W()
EulerMoreauOSI.getWBoundaryConditions()
EulerMoreauOSI.WBoundaryConditions()
EulerMoreauOSI.theta()
EulerMoreauOSI.setTheta()
EulerMoreauOSI.gamma()
EulerMoreauOSI.setGamma()
EulerMoreauOSI.useGamma()
EulerMoreauOSI.setUseGamma()
EulerMoreauOSI.useGammaForRelation()
EulerMoreauOSI.setUseGammaForRelation()
EulerMoreauOSI.initializeWorkVectorsForDS()
EulerMoreauOSI.initializeWorkVectorsForInteraction()
EulerMoreauOSI.numberOfIndexSets()
EulerMoreauOSI.initializeIterationMatrixW()
EulerMoreauOSI.computeW()
EulerMoreauOSI.computeWBoundaryConditions()
EulerMoreauOSI.initializeIterationMatrixWBoundaryConditions()
EulerMoreauOSI.computeResidu()
EulerMoreauOSI.computeFreeState()
EulerMoreauOSI.updateOutput()
EulerMoreauOSI.updateInput()
EulerMoreauOSI.computeResiduOutput()
EulerMoreauOSI.computeResiduInput()
EulerMoreauOSI.computeFreeOutput()
EulerMoreauOSI.prepareNewtonIteration()
EulerMoreauOSI.integrate()
EulerMoreauOSI.updateState()
EulerMoreauOSI.display()
MoreauJeanOSI
MoreauJeanOSI.getW()
MoreauJeanOSI.W()
MoreauJeanOSI.getWBoundaryConditions()
MoreauJeanOSI.WBoundaryConditions()
MoreauJeanOSI.theta()
MoreauJeanOSI.setTheta()
MoreauJeanOSI.gamma()
MoreauJeanOSI.setGamma()
MoreauJeanOSI.useGamma()
MoreauJeanOSI.setUseGamma()
MoreauJeanOSI.useGammaForRelation()
MoreauJeanOSI.setUseGammaForRelation()
MoreauJeanOSI.setConstraintActivationThreshold()
MoreauJeanOSI.constraintActivationThreshold()
MoreauJeanOSI.setConstraintActivationThresholdVelocity()
MoreauJeanOSI.constraintActivationThresholdVelocity()
MoreauJeanOSI.explicitNewtonEulerDSOperators()
MoreauJeanOSI.setExplicitNewtonEulerDSOperators()
MoreauJeanOSI.activateWithNegativeRelativeVelocity()
MoreauJeanOSI.setActivateWithNegativeRelativeVelocity()
MoreauJeanOSI.initialize_nonsmooth_problems()
MoreauJeanOSI.initializeWorkVectorsForDS()
MoreauJeanOSI.initializeWorkVectorsForInteraction()
MoreauJeanOSI.numberOfIndexSets()
MoreauJeanOSI.initializeIterationMatrixW()
MoreauJeanOSI.computeW()
MoreauJeanOSI.Winverse()
MoreauJeanOSI.computeInitialNewtonState()
MoreauJeanOSI.computeResidu()
MoreauJeanOSI.computeFreeState()
MoreauJeanOSI.computeFreeOutput()
MoreauJeanOSI.addInteractionInIndexSet()
MoreauJeanOSI.removeInteractionFromIndexSet()
MoreauJeanOSI.prepareNewtonIteration()
MoreauJeanOSI.integrate()
MoreauJeanOSI.updatePosition()
MoreauJeanOSI.updateState()
MoreauJeanOSI.computeWorkForces()
MoreauJeanOSI.display()
MoreauJeanBilbaoOSI
MoreauJeanBilbaoOSI.initializeWorkVectorsForDS()
MoreauJeanBilbaoOSI.initializeWorkVectorsForInteraction()
MoreauJeanBilbaoOSI.computeInitialNewtonState()
MoreauJeanBilbaoOSI.initialize_nonsmooth_problems()
MoreauJeanBilbaoOSI.numberOfIndexSets()
MoreauJeanBilbaoOSI.iteration_matrix()
MoreauJeanBilbaoOSI.integrate()
MoreauJeanBilbaoOSI.computeResidu()
MoreauJeanBilbaoOSI.computeFreeState()
MoreauJeanBilbaoOSI.computeFreeOutput()
MoreauJeanBilbaoOSI.updatePosition()
MoreauJeanBilbaoOSI.updateState()
MoreauJeanBilbaoOSI.display()
MoreauJeanBilbaoOSI.addInteractionInIndexSet()
MoreauJeanBilbaoOSI.removeInteractionFromIndexSet()
MoreauJeanCombinedProjectionOSI
MoreauJeanCombinedProjectionOSI.initializeWorkVectorsForDS()
MoreauJeanCombinedProjectionOSI.initializeWorkVectorsForInteraction()
MoreauJeanCombinedProjectionOSI.numberOfIndexSets()
MoreauJeanCombinedProjectionOSI.addInteractionInIndexSet()
MoreauJeanCombinedProjectionOSI.removeInteractionFromIndexSet()
MoreauJeanDirectProjectionOSI
MoreauJeanDirectProjectionOSI.initializeWorkVectorsForDS()
MoreauJeanDirectProjectionOSI.initializeWorkVectorsForInteraction()
MoreauJeanDirectProjectionOSI.numberOfIndexSets()
MoreauJeanDirectProjectionOSI.addInteractionInIndexSet()
MoreauJeanDirectProjectionOSI.removeInteractionFromIndexSet()
MoreauJeanDirectProjectionOSI.computeFreeState()
MoreauJeanGOSI
ZeroOrderHoldOSI
ZeroOrderHoldOSI.Ad()
ZeroOrderHoldOSI.Bd()
ZeroOrderHoldOSI.initializeWorkVectorsForDS()
ZeroOrderHoldOSI.initializeWorkVectorsForInteraction()
ZeroOrderHoldOSI.numberOfIndexSets()
ZeroOrderHoldOSI.computeResidu()
ZeroOrderHoldOSI.computeFreeState()
ZeroOrderHoldOSI.computeFreeOutput()
ZeroOrderHoldOSI.addInteractionInIndexSet()
ZeroOrderHoldOSI.removeInteractionFromIndexSet()
ZeroOrderHoldOSI.prepareNewtonIteration()
ZeroOrderHoldOSI.integrate()
ZeroOrderHoldOSI.updateState()
ZeroOrderHoldOSI.display()
Simulation
Simulation.clear()
Simulation.name()
Simulation.setName()
Simulation.getTk()
Simulation.getTkp1()
Simulation.getTkp2()
Simulation.currentTimeStep()
Simulation.eventsManager()
Simulation.startingTime()
Simulation.nextTime()
Simulation.timeStep()
Simulation.hasNextEvent()
Simulation.oneStepIntegrators()
Simulation.numberOfOSI()
Simulation.insertIntegrator()
Simulation.associate()
Simulation.indexSet()
Simulation.oneStepNSProblems()
Simulation.numberOfOSNSProblems()
Simulation.oneStepNSProblem()
Simulation.insertNonSmoothProblem()
Simulation.nonSmoothDynamicalSystem()
Simulation.setNonSmoothDynamicalSystemPtr()
Simulation.tolerance()
Simulation.setTolerance()
Simulation.setPrintStat()
Simulation.getPrintStat()
Simulation.updateIndexSets()
Simulation.updateIndexSet()
Simulation.initialize()
Simulation.initializeInteraction()
Simulation.insertInteractionManager()
Simulation.computeResidu()
Simulation.computeOneStepNSProblem()
Simulation.updateDSPlugins()
Simulation.updateInput()
Simulation.updateAllInput()
Simulation.updateState()
Simulation.updateOutput()
Simulation.update()
Simulation.run()
Simulation.initializeOneStepNSProblem()
Simulation.advanceToEvent()
Simulation.clearNSDSChangeLog()
Simulation.setUseRelativeConvergenceCriteron()
Simulation.useRelativeConvergenceCriteron()
Simulation.setRelativeConvergenceTol()
Simulation.relativeConvergenceTol()
Simulation.setRelativeConvergenceCriterionHeld()
Simulation.relativeConvergenceCriterionHeld()
Simulation.lambda_()
Simulation.y()
Simulation.processEvents()
Simulation.setStaticLevels()
Simulation.updateT()
Simulation.link()
Simulation.unlink()
Simulation.updateInteractions()
Simulation.initializeOSIAssociations()
Simulation.initializeNSDSChangelog()
Simulation.initializeIndexSets()
Simulation.firstInitialize()
SICONOS_TS_LINEAR
TimeStepping
TimeStepping.newtonSolve()
TimeStepping.initializeOneStepNSProblem()
TimeStepping.insertIntegrator()
TimeStepping.updateIndexSet()
TimeStepping.nextStep()
TimeStepping.computeFreeState()
TimeStepping.resetLambdas()
TimeStepping.advanceToEvent()
TimeStepping.computeOneStep()
TimeStepping.getNewtonNbIterations()
TimeStepping.getNewtonCumulativeNbIterations()
TimeStepping.initializeNewtonSolve()
TimeStepping.newtonCheckConvergence()
TimeStepping.run()
TimeStepping.DefaultCheckSolverOutput()
TimeStepping.setCheckSolverFunction()
TimeStepping.setComputeResiduY()
TimeStepping.computeResiduY()
TimeStepping.setComputeResiduR()
TimeStepping.computeResiduR()
TimeStepping.setNewtonTolerance()
TimeStepping.newtonTolerance()
TimeStepping.setNewtonMaxIteration()
TimeStepping.newtonMaxIteration()
TimeStepping.setNewtonOptions()
TimeStepping.newtonOptions()
TimeStepping.newtonResiduDSMax()
TimeStepping.newtonResiduYMax()
TimeStepping.newtonResiduRMax()
TimeSteppingCombinedProjection
TimeSteppingCombinedProjection.updateIndexSet()
TimeSteppingCombinedProjection.initializeOneStepNSProblem()
TimeSteppingCombinedProjection.nbProjectionIteration()
TimeSteppingCombinedProjection.nbCumulatedProjectionIteration()
TimeSteppingCombinedProjection.cumulatedNewtonNbIterations()
TimeSteppingCombinedProjection.nbIndexSetsIteration()
TimeSteppingCombinedProjection.advanceToEvent()
TimeSteppingCombinedProjection.newtonSolve()
TimeSteppingDirectProjection
EventDriven
EventDriven.initialize()
EventDriven.firstInitialize()
EventDriven.setIstate()
EventDriven.istate()
EventDriven.setToleranceED()
EventDriven.toleranceED()
EventDriven.isNewtonConverge()
EventDriven.getNewtonNbIterations()
EventDriven.setNewtonMaxIteration()
EventDriven.setLocalizeEventsMaxIteration()
EventDriven.newtonMaxIteration()
EventDriven.LocalizeEventsMaxIteration()
EventDriven.newtonResiduDSMax()
EventDriven.newtonResiduYMax()
EventDriven.setNewtonTolerance()
EventDriven.newtonTolerance()
EventDriven.insertIntegrator()
EventDriven.updateIndexSet()
EventDriven.updateIndexSetsWithDoubleCondition()
EventDriven.computef()
EventDriven.computeJacobianfx()
EventDriven.computeSizeOfg()
EventDriven.computeg()
EventDriven.updateImpactState()
EventDriven.updateSmoothState()
EventDriven.updateInput()
EventDriven.updateState()
EventDriven.updateOutput()
EventDriven.advanceToEvent()
EventDriven.computeResiduConstraints()
EventDriven.prepareNewtonIteration()
EventDriven.newtonCheckConvergence()
EventDriven.predictionNewtonIteration()
EventDriven.correctionNewtonIteration()
EventDriven.newtonSolve()
EventDriven.detectEvents()
EventDriven.LocalizeFirstEvent()
EventsManager
EventsManager.insertEv()
EventsManager.update()
EventsManager.initialize()
EventsManager.setGapLimitEvents()
EventsManager.getGapLimitEvents()
EventsManager.noSaveInMemory()
EventsManager.currentEvent()
EventsManager.nextEvent()
EventsManager.events()
EventsManager.hasNextEvent()
EventsManager.startingTime()
EventsManager.nextTime()
EventsManager.needsIntegration()
EventsManager.display()
EventsManager.scheduleNonSmoothEvent()
EventsManager.processEvents()
EventsManager.preUpdate()
EventsManager.insertEvent()
EventsManager.getTkp1()
EventsManager.getTkp2()
EventsManager.getTkp3()
EventsManager.currentTimeStep()
EventsManager.timeDiscretisation()
EventsManager.updateT()
Event
BoundaryCondition
HarmonicBC
FixedBC
OSNSMatrix
OSNSMatrix.size()
OSNSMatrix.setSize()
OSNSMatrix.sizeColumn()
OSNSMatrix.storagetype()
OSNSMatrix.setStorageType()
OSNSMatrix.numericsMatrix()
OSNSMatrix.defaultMatrix()
OSNSMatrix.fillM()
OSNSMatrix.computeM()
OSNSMatrix.fillW()
OSNSMatrix.fillWinverse()
OSNSMatrix.fillH()
OSNSMatrix.fillHtrans()
OSNSMatrix.convert()
OSNSMatrix.display()
BlockCSRMatrix
BlockCSRMatrix.numberOfBlocksInARow()
BlockCSRMatrix.getNbNonNullBlocks()
BlockCSRMatrix.getNumericsMatSparse()
BlockCSRMatrix.getMSparse()
BlockCSRMatrix.getSizeOfDiagonalBlock()
BlockCSRMatrix.getPositionsIndex()
BlockCSRMatrix.fill()
BlockCSRMatrix.fillW()
BlockCSRMatrix.fillH()
BlockCSRMatrix.convert()
BlockCSRMatrix.display()
- siconos.control.observer
- siconos.control.sensor
- siconos.control.controller
nullDeleter
Actuator
PID
CommonSMC
CommonSMC.computeUeq()
CommonSMC.actuate()
CommonSMC.initialize()
CommonSMC.setg()
CommonSMC.setCsurface()
CommonSMC.setSaturationMatrix()
CommonSMC.setAlpha()
CommonSMC.lambda_()
CommonSMC.setSolver()
CommonSMC.setPrecision()
CommonSMC.relay()
CommonSMC.ueq()
CommonSMC.us()
CommonSMC.setTheta()
CommonSMC.noUeq()
CommonSMC.setComputeResidus()
CommonSMC.setTimeDiscretisation()
CommonSMC.setDS()
CommonSMC.getInternalNSDS()
CommonSMC.getInternalOSI()
LinearSMC
ExplicitLinearSMC
LinearSMCOT2
LinearSMCimproved
Twisting
RegularTwisting
ExplicitTwisting
- siconos.mechanics.joints
nullDeleter
NewtonEulerJointR
NewtonEulerJointR.setPoint()
NewtonEulerJointR.point()
NewtonEulerJointR.points()
NewtonEulerJointR.setAxis()
NewtonEulerJointR.axis()
NewtonEulerJointR.axes()
NewtonEulerJointR.setAbsolute()
NewtonEulerJointR.absolute()
NewtonEulerJointR.setBasePositions()
NewtonEulerJointR.computehDoF()
NewtonEulerJointR.computeJachqDoF()
NewtonEulerJointR.allowSelfCollide()
NewtonEulerJointR.setAllowSelfCollide()
NewtonEulerJointR.numberOfConstraints()
NewtonEulerJointR.numberOfDoF()
NewtonEulerJointR.typeOfDoF()
KneeJointR
PivotJointR
PrismaticJointR
FixedJointR
CylindricalJointR
CouplerJointR
JointStopR
JointFrictionR
- siconos.control.simulation
nullDeleter
ControlManager
ControlManager.linkSensorSimulation()
ControlManager.linkActuatorSimulation()
ControlManager.linkObserverSimulation()
ControlManager.simulation()
ControlManager.getSensors()
ControlManager.getActuators()
ControlManager.getObservers()
ControlManager.addSensor()
ControlManager.addAndRecordSensor()
ControlManager.addSensorPtr()
ControlManager.addAndRecordSensorPtr()
ControlManager.addActuator()
ControlManager.addAndRecordActuator()
ControlManager.addActuatorPtr()
ControlManager.addAndRecordActuatorPtr()
ControlManager.addObserver()
ControlManager.addAndRecordObserver()
ControlManager.addObserverPtr()
ControlManager.addAndRecordObserverPtr()
ControlManager.initialize()
ControlManager.display()
- siconos.mechanics.collision.base
- siconos.mechanics.collision.bullet
nullDeleter
SiconosBodies
SiconosContactor
ContactR
RigidBodyDS
Contact5DR
RigidBody2dDS
SiconosCollisionQueryResult
btVector3
btVector3.dot()
btVector3.length2()
btVector3.length()
btVector3.norm()
btVector3.safeNorm()
btVector3.distance2()
btVector3.distance()
btVector3.normalize()
btVector3.normalized()
btVector3.rotate()
btVector3.angle()
btVector3.absolute()
btVector3.cross()
btVector3.minAxis()
btVector3.maxAxis()
btVector3.lerp()
btVector3.getX()
btVector3.getY()
btVector3.getZ()
btVector3.setX()
btVector3.setY()
btVector3.setZ()
btVector3.setW()
btVector3.x()
btVector3.y()
btVector3.z()
btVector3.w()
btVector3.setMax()
btVector3.setMin()
btVector3.maxDot()
btVector3.minDot()
btDot()
btDistance2()
btDistance()
btCross()
lerp()
btSwapScalarEndian()
btSwapVector3Endian()
btUnSwapVector3Endian()
btQuadWord
btQuaternion
btQuaternion.setRotation()
btQuaternion.setEuler()
btQuaternion.setEulerZYX()
btQuaternion.getEulerZYX()
btQuaternion.dot()
btQuaternion.length2()
btQuaternion.length()
btQuaternion.normalize()
btQuaternion.normalized()
btQuaternion.angle()
btQuaternion.angleShortestPath()
btQuaternion.getAngle()
btQuaternion.getAngleShortestPath()
btQuaternion.getAxis()
btQuaternion.inverse()
btQuaternion.farthest()
btQuaternion.nearest()
btQuaternion.slerp()
dot()
length()
btAngle()
inverse()
slerp()
btMatrix3x3
btMatrix3x3.getColumn()
btMatrix3x3.getRow()
btMatrix3x3.setFromOpenGLSubMatrix()
btMatrix3x3.setValue()
btMatrix3x3.setRotation()
btMatrix3x3.setEulerYPR()
btMatrix3x3.setEulerZYX()
btMatrix3x3.setIdentity()
btMatrix3x3.setZero()
btMatrix3x3.getOpenGLSubMatrix()
btMatrix3x3.getRotation()
btMatrix3x3.getEulerYPR()
btMatrix3x3.getEulerZYX()
btMatrix3x3.scaled()
btMatrix3x3.determinant()
btMatrix3x3.adjoint()
btMatrix3x3.absolute()
btMatrix3x3.transpose()
btMatrix3x3.inverse()
btMatrix3x3.solve33()
btMatrix3x3.extractRotation()
btMatrix3x3.diagonalize()
btMatrix3x3.cofac()
btMatrix3x3FloatData
btMatrix3x3DoubleData
btTransform
btTransform.mult()
btTransform.getBasis()
btTransform.getOrigin()
btTransform.getRotation()
btTransform.setFromOpenGLMatrix()
btTransform.getOpenGLMatrix()
btTransform.setOrigin()
btTransform.setBasis()
btTransform.setRotation()
btTransform.setIdentity()
btTransform.inverse()
btTransform.inverseTimes()
btTransform.getIdentity()
btTransformFloatData
btDefaultCollisionConfiguration
btCollisionObject
btCollisionObject.CO_GHOST_OBJECT
btCollisionObject.setContactProcessingThreshold()
btCollisionObject.internalGetExtensionPointer()
btCollisionObject.internalSetExtensionPointer()
btCollisionObject.getInternalType()
btCollisionObject.getCcdSweptSphereRadius()
btCollisionObject.setCcdSweptSphereRadius()
btCollisionObject.setCcdMotionThreshold()
btCollisionObject.getUserPointer()
btCollisionObject.setUserPointer()
btCollisionObject.setUserIndex()
btCollisionObject.serialize()
btCollisionObjectDoubleData
btCollisionObjectFloatData
btDispatcher
btBroadphaseInterface
btCollisionWorld
btManifoldPoint
btPersistentManifold
btCollisionShape
btCollisionShapeData
btConvexShape
btConvexInternalShape
btConvexInternalShapeData
btConvexInternalAabbCachingShape
btConvex2dShape
btPolyhedralConvexShape
btPolyhedralConvexAabbCachingShape
btConvexHullShape
btConvexHullShapeData
btConvexPointCloudShape
TEST_INTERNAL_OBJECTS
btConvexTriangleMeshShape
btConcaveShape
btEmptyShape
btCompoundShape
btCompoundShapeChildData
btCompoundShapeData
btTriangleShape
btTriangleMesh
btTriangleMeshShape
btBox2dShape
btBoxShape
btCapsuleShape
btCapsuleShapeX
btCapsuleShapeData
btConeShape
btConeShapeData
btCylinderShape
btCylinderShapeX
btCylinderShapeZ
btCylinderShapeData
btHeightfieldTerrainShape
btMaterial
btMinkowskiSumShape
btSphereShape
btMultiSphereShape
btMultimaterialTriangleMeshShape
btOptimizedBvh
btScaledBvhTriangleMeshShape
btScaledTriangleMeshShapeData
btShapeHull
btStaticPlaneShape
btStaticPlaneShapeData
btStridingMeshInterface
btMeshPartData
btStridingMeshInterfaceData
btTriangleBuffer
btTriangleCallback
btIndexedMesh
btTriangleIndexVertexArray
btMaterialProperties
btTriangleIndexVertexMaterialArray
TRI_INFO_V0V1_CONVEX
btTriangleInfo
btTriangleInfoMap
btTriangleInfoData
btUniformScalingShape
btTetrahedronShapeEx
btGImpactShapeInterface
btGImpactShapeInterface.updateBound()
btGImpactShapeInterface.getAabb()
btGImpactShapeInterface.postUpdate()
btGImpactShapeInterface.getLocalBox()
btGImpactShapeInterface.getGImpactShapeType()
btGImpactShapeInterface.getBoxSet()
btGImpactShapeInterface.hasBoxSet()
btGImpactShapeInterface.getPrimitiveManager()
btGImpactShapeInterface.getNumChildShapes()
btGImpactShapeInterface.childrenHasTransform()
btGImpactShapeInterface.needsRetrieveTriangles()
btGImpactShapeInterface.needsRetrieveTetrahedrons()
btGImpactShapeInterface.lockChildShapes()
btGImpactShapeInterface.getPrimitiveTriangle()
btGImpactShapeInterface.getChildAabb()
btGImpactShapeInterface.getChildShape()
btGImpactShapeInterface.getChildTransform()
btGImpactShapeInterface.setChildTransform()
btGImpactShapeInterface.rayTest()
btGImpactShapeInterface.processAllTriangles()
btGImpactShapeInterface.processAllTrianglesRay()
btGImpactCompoundShape
btGImpactCompoundShape.childrenHasTransform()
btGImpactCompoundShape.getPrimitiveManager()
btGImpactCompoundShape.getCompoundPrimitiveManager()
btGImpactCompoundShape.getNumChildShapes()
btGImpactCompoundShape.addChildShape()
btGImpactCompoundShape.getChildShape()
btGImpactCompoundShape.getChildAabb()
btGImpactCompoundShape.getChildTransform()
btGImpactCompoundShape.setChildTransform()
btGImpactCompoundShape.needsRetrieveTriangles()
btGImpactCompoundShape.needsRetrieveTetrahedrons()
btGImpactCompoundShape.calculateLocalInertia()
btGImpactCompoundShape.getGImpactShapeType()
btGImpactMeshShapePart
btGImpactMeshShapePart.childrenHasTransform()
btGImpactMeshShapePart.lockChildShapes()
btGImpactMeshShapePart.getNumChildShapes()
btGImpactMeshShapePart.getChildShape()
btGImpactMeshShapePart.getChildTransform()
btGImpactMeshShapePart.setChildTransform()
btGImpactMeshShapePart.getPrimitiveManager()
btGImpactMeshShapePart.getGImpactShapeType()
btGImpactMeshShapePart.needsRetrieveTriangles()
btGImpactMeshShapePart.needsRetrieveTetrahedrons()
btGImpactMeshShapePart.processAllTriangles()
btGImpactMeshShapePart.processAllTrianglesRay()
btGImpactMeshShape
btGImpactMeshShape.postUpdate()
btGImpactMeshShape.getPrimitiveManager()
btGImpactMeshShape.getNumChildShapes()
btGImpactMeshShape.childrenHasTransform()
btGImpactMeshShape.needsRetrieveTriangles()
btGImpactMeshShape.needsRetrieveTetrahedrons()
btGImpactMeshShape.lockChildShapes()
btGImpactMeshShape.getChildAabb()
btGImpactMeshShape.getChildShape()
btGImpactMeshShape.getChildTransform()
btGImpactMeshShape.setChildTransform()
btGImpactMeshShape.getGImpactShapeType()
btGImpactMeshShape.rayTest()
btGImpactMeshShape.processAllTriangles()
btGImpactMeshShape.processAllTrianglesRay()
btGImpactMeshShape.serialize()
btGImpactMeshShapeData
BulletR
Bullet1DR
Bullet5DR
- siconos.mechanics.collision.native
- siconos.mechanics.collision.bodies
- siconos.io.io_base
If a file or a class you know does not appear in this page, it means it has not been (properly) documented or is not available in the high level API. Please contact us if you think it is an error.