Siconos 4.5.0
  • Sources on github
  • Index
  • Documentation
  • Siconos Documentation
      • Quickstart
        • What is Siconos?
        • Try it
        • Siconos usage in a few steps
        • More
          • Modeling Principle
          • Python interface : tutorials
            • Collections of rigid bodies with Bullet based contact detection (Siconos/Mechanics)
              • Description of the physical problems : rigid bodies collection with contact and Coulomb friction
            • Tutorial: A 4-diodes bridge wave rectifier
              • Preamble
              • Siconos driver file
              • Building a nonsmooth dynamical system
                • Modeling the dynamics
                • Modeling the interactions
              • Describing the simulation of the nonsmooth dynamical system
              • Leading the Simulation Process
          • Siconos tutorials in C++
            • Bouncing Ball
            • Tutorial : a column of three beads
              • Building the Non-Smooth Dynamical System
              • The Simulation
                • Time-Stepping scheme
                • Event-Driven algorithm
              • Simulation Process
                • Time-Stepping
                • Event-Driven
              • Results
            • Gene regulatory networks
            • Slider Crank
              • Usage
          • Simulation of an electrical oscillator supplying a resistor through a half-wave rectifier
            • Description of the physical problem : electrical oscillator with half-wave rectifier
            • Definition of a general abstract class of NSDS : the linear time invariant complementarity system (LCS)
              • Dynamical system and Boundary conditions
              • Relation between constrained variables and state variables
              • Definition of the Non Smooth Law between constrained variables
              • The formalization of the electrical oscillator with half-wave rectifier into the LCS
              • Dynamical equation
              • Relations
              • Non Smooth laws
            • Description of the numerical simulation: the Moreau’s time-stepping scheme
              • Time discretization of the dynamical system
              • Time discretization of the relations
              • Time discretization of the non-smooth law
              • Summary of the time discretized equations
              • Numerical simulation
            • Comparison with numerical results coming from SPICE models and algorithms
              • Characteristic of the diode in the SPICE model
              • Simulation results
          • Running a simulation
            • Basics
            • Plugins mechanism
            • Extra source files
          • C++ Refresher
            • Building/destroying and using objects
            • Members/Methods access
            • Matrices and vectors handling
              • Read/write vectors and matrices from/to file
              • Methods and operations on matrices and vectors
              • About efficiency
      • Download and install
        • Download Siconos
          • Packages
          • Latest source release
          • Development sources
        • Build and install
          • Overview
          • Installation from sources
            • Prerequisites
            • The quick way
            • Detailed installation
            • Siconos package description
            • Running siconos tests
            • What will be installed?
              • Remark
            • CMake options
              • Most common options
              • Developers or advanced users options
            • User-defined option file
            • Test your installation
          • Repositories
            • Debian bullseye
            • FreeBSD
        • Siconos required and optional dependencies
        • About blas and Lapack
        • About Boost
        • GMP
      • Browse examples
        • Gallery
      • API reference
        • Siconos C/C++ API reference
          • 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.
            • Classes and structs
            • Files documentation
          • Kernel: high-level API to modelise and simulate nonsmooth dynamical systems.
            • Classes and structs
            • Files documentation
          • Control: control toolbox
            • Classes and structs
            • Files documentation
          • Mechanics: toolbox for collision detection and joints
            • Classes and structs
            • Files documentation
          • Io: tools related to input/outputs (hdf5, vtk …)
            • Classes and structs
            • Files documentation
        • Siconos Python API reference
          • 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
              • Callback.env
              • Callback.collectStatsIteration
            • 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_factors.n
              • CSparseMatrix_factors.S
              • CSparseMatrix_factors.N
            • 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
              • SparseBlockStructuredMatrix.version
            • 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
              • NumericsMatrix.storageType
              • NumericsMatrix.size0
              • NumericsMatrix.size1
              • NumericsMatrix.matrix0
              • NumericsMatrix.matrix1
              • NumericsMatrix.matrix2
              • NumericsMatrix.internalData
              • NumericsMatrix.destructible
            • 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
              • NSM_linear_solver_params.linear_solver_data
              • NSM_linear_solver_params.solver_free_hook
              • NSM_linear_solver_params.iWork
              • NSM_linear_solver_params.iWorkSize
              • NSM_linear_solver_params.linalg_data
            • NumericsSparseMatrix
              • NumericsSparseMatrix.triplet
              • NumericsSparseMatrix.half_triplet
              • NumericsSparseMatrix.csc
              • NumericsSparseMatrix.trans_csc
              • NumericsSparseMatrix.csr
              • NumericsSparseMatrix.diag_indx
              • NumericsSparseMatrix.origin
              • NumericsSparseMatrix.linearSolverParams
            • 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_max_version()
            • NSM_set_version()
            • NSM_reset_versions()
            • NSM_reset_version()
            • NSM_inc_version()
            • NSM_latest_id()
            • NSM_latest()
            • NSM_version_sync()
            • NM_MUMPS_copy()
            • MLCP
              • MLCP.isStorageType1
              • MLCP.isStorageType2
              • MLCP.n
              • MLCP.m
              • MLCP.blocksRows
              • MLCP.blocksIsComp
              • MLCP.M
              • MLCP.q
              • MLCP.A
              • MLCP.B
              • MLCP.C
              • MLCP.D
              • MLCP.a
              • MLCP.b
            • 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
              • LCP.size
              • LCP.M
              • LCP.q
            • 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.size
              • AVI.M
              • AVI.q
              • AVI.d
              • AVI.poly
              • AVI.lb
              • AVI.ub
              • AVI.cones
            • 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.n1
              • MCP.n2
              • MCP.compute_Fmcp
              • MCP.compute_nabla_Fmcp
              • MCP.nabla_Fmcp
              • MCP.env
            • MCP_old
              • MCP_old.sizeEqualities
              • MCP_old.sizeInequalities
              • MCP_old.computeFmcp
              • MCP_old.Fmcp
              • MCP_old.nablaFmcp
            • 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
              • NCP.n
              • NCP.compute_F
              • NCP.compute_nabla_F
              • NCP.nabla_F
              • NCP.env
            • 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.n
              • SecondOrderConeLinearComplementarityProblem.nc
              • SecondOrderConeLinearComplementarityProblem.M
              • SecondOrderConeLinearComplementarityProblem.q
              • SecondOrderConeLinearComplementarityProblem.coneIndex
              • SecondOrderConeLinearComplementarityProblem.tau
            • 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.dimension
              • FrictionContactProblem.numberOfContacts
              • FrictionContactProblem.M
              • FrictionContactProblem.q
              • FrictionContactProblem.mu
            • 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_int.name
              • GAMS_opt_int.value
              • GAMS_opt_int.type
              • GAMS_opt_int.next_opt
            • GAMS_opt_double
              • GAMS_opt_double.name
              • GAMS_opt_double.value
              • GAMS_opt_double.type
              • GAMS_opt_double.next_opt
            • GAMS_opt_str
              • GAMS_opt_str.name
              • GAMS_opt_str.value
              • GAMS_opt_str.type
              • GAMS_opt_str.next_opt
            • SN_GAMSparams
              • SN_GAMSparams.model_dir
              • SN_GAMSparams.gams_dir
              • SN_GAMSparams.filename
              • SN_GAMSparams.filename_suffix
              • SN_GAMSparams.opt_str_list
              • SN_GAMSparams.opt_bool_list
              • SN_GAMSparams.opt_int_list
              • SN_GAMSparams.opt_double_list
            • 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.dimension
              • RollingFrictionContactProblem.numberOfContacts
              • RollingFrictionContactProblem.M
              • RollingFrictionContactProblem.q
              • RollingFrictionContactProblem.mu
              • RollingFrictionContactProblem.mu_r
            • 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.randomize_sym()
              • 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.randomize_sym()
              • 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
              • Callback.env
              • Callback.collectStatsIteration
            • 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()
            • LEVELMAX
            • ioMatrix_read()
            • ioMatrix_write()
            • compareRefFile()
            • TD_EVENT
            • DENSE
            • TRIANGULAR
            • SYMMETRIC
            • SPARSE
            • BANDED
            • ZERO
            • IDENTITY
            • SPARSE_COORDINATE
            • SiconosMemory
              • SiconosMemory.getSiconosVector()
              • SiconosMemory.getSiconosVectorMutable()
              • SiconosMemory.setMemorySize()
              • SiconosMemory.nbVectorsInMemory()
              • SiconosMemory.display()
            • NonSmoothLaw
              • NonSmoothLaw.isVerified()
              • NonSmoothLaw.size()
              • NonSmoothLaw.display()
            • NewtonImpactNSL
              • NewtonImpactNSL.isVerified()
              • NewtonImpactNSL.e()
              • NewtonImpactNSL.setE()
              • NewtonImpactNSL.display()
            • NewtonImpactFrictionNSL
              • NewtonImpactFrictionNSL.isVerified()
              • NewtonImpactFrictionNSL.en()
              • NewtonImpactFrictionNSL.setEn()
              • NewtonImpactFrictionNSL.et()
              • NewtonImpactFrictionNSL.setEt()
              • NewtonImpactFrictionNSL.mu()
              • NewtonImpactFrictionNSL.setMu()
              • NewtonImpactFrictionNSL.display()
            • NewtonImpactRollingFrictionNSL
              • NewtonImpactRollingFrictionNSL.isVerified()
              • NewtonImpactRollingFrictionNSL.en()
              • NewtonImpactRollingFrictionNSL.setEn()
              • NewtonImpactRollingFrictionNSL.et()
              • NewtonImpactRollingFrictionNSL.setEt()
              • NewtonImpactRollingFrictionNSL.mu()
              • NewtonImpactRollingFrictionNSL.muR()
              • NewtonImpactRollingFrictionNSL.setMu()
              • NewtonImpactRollingFrictionNSL.setMuR()
              • NewtonImpactRollingFrictionNSL.display()
            • MixedComplementarityConditionNSL
              • MixedComplementarityConditionNSL.display()
              • MixedComplementarityConditionNSL.equalitySize()
            • ComplementarityConditionNSL
              • ComplementarityConditionNSL.display()
            • EqualityConditionNSL
              • EqualityConditionNSL.display()
            • MultipleImpactNSL
              • MultipleImpactNSL.isVerified()
              • MultipleImpactNSL.display()
            • RelayNSL
              • RelayNSL.isVerified()
              • RelayNSL.lb()
              • RelayNSL.setLb()
              • RelayNSL.ub()
              • RelayNSL.setUb()
              • RelayNSL.display()
            • NormalConeNSL
              • NormalConeNSL.H()
              • NormalConeNSL.K()
              • NormalConeNSL.isVerified()
              • NormalConeNSL.display()
            • 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()
            • DynamicalSystem_resetCount()
            • 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
              • LinearComplementaritySystemsNSDS.interaction()
            • 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
              • FirstOrderLinearTIDS.initRhs()
              • FirstOrderLinearTIDS.computeRhs()
              • FirstOrderLinearTIDS.computeJacobianRhsx()
              • FirstOrderLinearTIDS.display()
              • FirstOrderLinearTIDS.updatePlugins()
            • 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
              • LagrangianR.initialize()
              • LagrangianR.jachq()
              • LagrangianR.setJachqPtr()
              • LagrangianR.display()
            • 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
              • NewtonEuler3DR.initialize()
              • NewtonEuler3DR.computeJachqT()
              • NewtonEuler3DR.display()
            • NewtonEuler5DR
              • NewtonEuler5DR.initialize()
              • NewtonEuler5DR.computeJachqT()
            • FirstOrderR
              • FirstOrderR.initialize()
              • FirstOrderR.setCPtr()
              • FirstOrderR.setBPtr()
              • FirstOrderR.setDPtr()
              • FirstOrderR.setFPtr()
              • FirstOrderR.C()
              • FirstOrderR.H()
              • FirstOrderR.D()
              • FirstOrderR.F()
              • FirstOrderR.B()
              • FirstOrderR.K()
            • 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()
            • Interaction_resetCount()
            • TimeDiscretisation
              • TimeDiscretisation.currentTimeStep()
              • TimeDiscretisation.hConst()
              • TimeDiscretisation.hGmp()
              • TimeDiscretisation.getTk()
              • TimeDiscretisation.getTkVector()
              • TimeDiscretisation.setTkVector()
              • TimeDiscretisation.setT0()
              • TimeDiscretisation.display()
            • 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.update_interaction_output()
              • 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()
            • LsodarOSI_count_rhs_call()
            • LsodarOSI_count_steps()
            • LCP
              • LCP.solve()
              • LCP.compute()
            • AVI
              • AVI.initialize()
              • AVI.compute()
              • AVI.checkCompatibleNSLaw()
              • AVI.display()
            • QP
              • QP.getQ()
              • QP.q()
              • QP.setQ()
              • QP.setQPtr()
              • QP.getP()
              • QP.p()
              • QP.setP()
              • QP.setPPtr()
              • QP.compute()
              • QP.display()
              • QP.computeInteractionBlock()
              • QP.computeDiagonalInteractionBlock()
              • QP.preCompute()
              • QP.postCompute()
            • Relay
              • Relay.getLb()
              • Relay.lb()
              • Relay.setLb()
              • Relay.getUb()
              • Relay.ub()
              • Relay.setUb()
              • Relay.initialize()
              • Relay.compute()
              • Relay.checkCompatibleNSLaw()
              • Relay.display()
            • MLCP
              • MLCP.computeOptions()
              • MLCP.updateInteractionBlocks()
              • MLCP.getn()
              • MLCP.getNumericsMLCP()
              • MLCP.reset()
              • MLCP.computeInteractionBlock()
              • MLCP.computeDiagonalInteractionBlock()
              • MLCP.compute()
              • MLCP.solve()
              • MLCP.display()
              • MLCP.checkCompatibleNSLaw()
            • 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
              • GenericMechanical.initialize()
              • GenericMechanical.compute()
              • GenericMechanical.computeInteractionBlock()
              • GenericMechanical.computeDiagonalInteractionBlock()
              • GenericMechanical.display()
              • GenericMechanical.updateInteractionBlocks()
              • GenericMechanical.checkCompatibleNSLaw()
            • 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.explicitNewtonEulerDSOperators()
              • MoreauJeanOSI.setExplicitNewtonEulerDSOperators()
              • 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.display()
            • MoreauJeanBilbaoOSI
              • MoreauJeanBilbaoOSI.initializeWorkVectorsForDS()
              • MoreauJeanBilbaoOSI.initializeWorkVectorsForInteraction()
              • 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
              • MoreauJeanGOSI.initializeWorkVectorsForDS()
              • MoreauJeanGOSI.initializeWorkVectorsForInteraction()
              • MoreauJeanGOSI.computeResidu()
              • MoreauJeanGOSI.computeFreeState()
              • MoreauJeanGOSI.integrate()
              • MoreauJeanGOSI.updateState()
              • MoreauJeanGOSI.NonSmoothLawContributionToOutput()
              • MoreauJeanGOSI.display()
            • 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.initOSNS()
              • 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.initOSNS()
              • TimeStepping.insertIntegrator()
              • TimeStepping.updateIndexSet()
              • TimeStepping.nextStep()
              • TimeStepping.computeFreeState()
              • TimeStepping.resetLambdas()
              • TimeStepping.advanceToEvent()
              • TimeStepping.computeOneStep()
              • TimeStepping.getNewtonNbIterations()
              • TimeStepping.getNewtonCumulativeNbIterations()
              • TimeStepping.initializeNewtonLoop()
              • 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.initOSNS()
              • TimeSteppingCombinedProjection.nbProjectionIteration()
              • TimeSteppingCombinedProjection.nbCumulatedProjectionIteration()
              • TimeSteppingCombinedProjection.cumulatedNewtonNbIterations()
              • TimeSteppingCombinedProjection.nbIndexSetsIteration()
              • TimeSteppingCombinedProjection.advanceToEvent()
              • TimeSteppingCombinedProjection.newtonSolve()
            • TimeSteppingDirectProjection
              • TimeSteppingDirectProjection.initOSNS()
              • TimeSteppingDirectProjection.nbProjectionIteration()
              • TimeSteppingDirectProjection.advanceToEvent()
              • TimeSteppingDirectProjection.nextStep()
              • TimeSteppingDirectProjection.newtonSolve()
            • 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
              • Event.getTick()
              • Event.setTick()
              • Event.getTimeOfEvent()
              • Event.getDoubleTimeOfEvent()
              • Event.setTime()
              • Event.getType()
              • Event.setType()
              • Event.setK()
              • Event.setTimeDiscretisation()
              • Event.getTimeDiscretisation()
              • Event.display()
              • Event.process()
              • Event.update()
            • Event_setTick()
            • BoundaryCondition
              • BoundaryCondition.velocityIndices()
              • BoundaryCondition.prescribedVelocity()
              • BoundaryCondition.prescribedVelocityOld()
              • BoundaryCondition.setComputePrescribedVelocityFunction()
              • BoundaryCondition.computePrescribedVelocity()
              • BoundaryCondition.display()
            • HarmonicBC
              • HarmonicBC.computePrescribedVelocity()
            • FixedBC
              • FixedBC.computePrescribedVelocity()
            • 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.controller
            • nullDeleter
            • Actuator
              • Actuator.setId()
              • Actuator.getId()
              • Actuator.getType()
              • Actuator.u()
              • Actuator.setSizeu()
              • Actuator.setB()
              • Actuator.setg()
              • Actuator.addSensorPtr()
              • Actuator.setTimeDiscretisation()
              • Actuator.initialize()
              • Actuator.actuate()
              • Actuator.display()
              • Actuator.getInternalNSDS()
            • PID
              • PID.initialize()
              • PID.actuate()
              • PID.setK()
              • PID.setRef()
              • PID.setTimeDiscretisation()
              • PID.display()
            • 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
              • LinearSMC.actuate()
              • LinearSMC.setDPtr()
            • ExplicitLinearSMC
              • ExplicitLinearSMC.initialize()
              • ExplicitLinearSMC.actuate()
            • LinearSMCOT2
              • LinearSMCOT2.initialize()
              • LinearSMCOT2.actuate()
              • LinearSMCOT2.setTimeDiscretisation()
            • LinearSMCimproved
              • LinearSMCimproved.predictionPerturbation()
              • LinearSMCimproved.initialize()
              • LinearSMCimproved.actuate()
              • LinearSMCimproved.setPerturbationPrediction()
              • LinearSMCimproved.up()
              • LinearSMCimproved.setPredictionOrder()
            • Twisting
              • Twisting.actuate()
              • Twisting.setNSdata()
              • Twisting.initialize()
            • RegularTwisting
            • ExplicitTwisting
              • ExplicitTwisting.actuate()
              • ExplicitTwisting.initialize()
          • siconos.control.observer
            • nullDeleter
            • Observer
              • Observer.setId()
              • Observer.getId()
              • Observer.getType()
              • Observer.setTimeDiscretisation()
              • Observer.initialize()
              • Observer.process()
              • Observer.display()
              • Observer.e()
              • Observer.xHat()
              • Observer.setDS()
              • Observer.getInternalNSDS()
            • LuenbergerObserver
              • LuenbergerObserver.process()
              • LuenbergerObserver.initialize()
              • LuenbergerObserver.setLPtr()
              • LuenbergerObserver.setCPtr()
            • SlidingReducedOrderObserver
              • SlidingReducedOrderObserver.process()
              • SlidingReducedOrderObserver.initialize()
              • SlidingReducedOrderObserver.setLPtr()
              • SlidingReducedOrderObserver.setCPtr()
          • siconos.control.sensor
            • nullDeleter
            • Sensor
              • Sensor.setId()
              • Sensor.getId()
              • Sensor.getType()
              • Sensor.getDS()
              • Sensor.setTimeDiscretisation()
              • Sensor.initialize()
              • Sensor.capture()
              • Sensor.display()
            • ControlSensor
              • ControlSensor.initialize()
              • ControlSensor.getYDim()
              • ControlSensor.y()
              • ControlSensor.capture()
            • LinearSensor
              • LinearSensor.initialize()
              • LinearSensor.capture()
              • LinearSensor.setC()
              • LinearSensor.setCPtr()
              • LinearSensor.setD()
              • LinearSensor.setDPtr()
          • 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
              • KneeJointR.initialize()
              • KneeJointR.setBasePositions()
              • KneeJointR.checkInitPos()
              • KneeJointR.numberOfConstraints()
              • KneeJointR.numberOfDoF()
              • KneeJointR.typeOfDoF()
              • KneeJointR.computeJachq()
              • KneeJointR.computeh()
            • PivotJointR
              • PivotJointR.setBasePositions()
              • PivotJointR.computeh()
              • PivotJointR.computehDoF()
              • PivotJointR.computeJachqDoF()
              • PivotJointR.numberOfConstraints()
              • PivotJointR.numberOfDoF()
              • PivotJointR.typeOfDoF()
            • PrismaticJointR
              • PrismaticJointR.setBasePositions()
              • PrismaticJointR.computehDoF()
              • PrismaticJointR.computeJachqDoF()
              • PrismaticJointR.computeJachq()
              • PrismaticJointR.computeh()
              • PrismaticJointR.numberOfConstraints()
              • PrismaticJointR.numberOfDoF()
              • PrismaticJointR.typeOfDoF()
            • FixedJointR
              • FixedJointR.setBasePositions()
              • FixedJointR.numberOfConstraints()
              • FixedJointR.computeJachq()
              • FixedJointR.computeh()
              • FixedJointR.numberOfDoF()
              • FixedJointR.typeOfDoF()
            • CylindricalJointR
              • CylindricalJointR.setBasePositions()
              • CylindricalJointR.computeJachq()
              • CylindricalJointR.computeh()
              • CylindricalJointR.computehDoF()
              • CylindricalJointR.computeJachqDoF()
              • CylindricalJointR.numberOfConstraints()
              • CylindricalJointR.numberOfDoF()
              • CylindricalJointR.typeOfDoF()
            • CouplerJointR
              • CouplerJointR.makeBlockVectors()
              • CouplerJointR.computeh()
              • CouplerJointR.computeJachq()
              • CouplerJointR.setReferences()
              • CouplerJointR.setBasePositions()
              • CouplerJointR.numberOfConstraints()
              • CouplerJointR.numberOfDoF()
              • CouplerJointR.typeOfDoF()
              • CouplerJointR.computehDoF()
              • CouplerJointR.computeJachqDoF()
            • JointStopR
              • JointStopR.computeh()
              • JointStopR.computeJachq()
              • JointStopR.axis()
              • JointStopR.position()
              • JointStopR.direction()
              • JointStopR.joint()
              • JointStopR.numberOfAxes()
            • JointFrictionR
              • JointFrictionR.computeh()
              • JointFrictionR.computeJachq()
              • JointFrictionR.axis()
              • JointFrictionR.joint()
              • JointFrictionR.numberOfAxes()
          • 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
            • nullDeleter
            • SiconosContactor
            • ContactR
              • ContactR.computeh()
              • ContactR.updateContactPoints()
              • ContactR.display()
            • RigidBodyDS
              • RigidBodyDS.allowSelfCollide()
              • RigidBodyDS.setAllowSelfCollide()
              • RigidBodyDS.contactors()
              • RigidBodyDS.setContactors()
              • RigidBodyDS.base_position()
            • Contact5DR
              • Contact5DR.computeh()
              • Contact5DR.updateContactPoints()
            • RigidBody2dDS
              • RigidBody2dDS.allowSelfCollide()
              • RigidBody2dDS.setAllowSelfCollide()
              • RigidBody2dDS.contactors()
              • RigidBody2dDS.setContactors()
              • RigidBody2dDS.base_position()
            • SiconosCollisionQueryResult
              • SiconosCollisionQueryResult.distance
              • SiconosCollisionQueryResult.body
              • SiconosCollisionQueryResult.shape
              • SiconosCollisionQueryResult.contactor
              • SiconosCollisionQueryResult.point
          • siconos.mechanics.collision.bullet
            • nullDeleter
            • SiconosBodies
            • SiconosContactor
            • ContactR
              • ContactR.computeh()
              • ContactR.updateContactPoints()
              • ContactR.display()
            • RigidBodyDS
              • RigidBodyDS.allowSelfCollide()
              • RigidBodyDS.setAllowSelfCollide()
              • RigidBodyDS.contactors()
              • RigidBodyDS.setContactors()
              • RigidBodyDS.base_position()
            • Contact5DR
              • Contact5DR.computeh()
              • Contact5DR.updateContactPoints()
            • RigidBody2dDS
              • RigidBody2dDS.allowSelfCollide()
              • RigidBody2dDS.setAllowSelfCollide()
              • RigidBody2dDS.contactors()
              • RigidBody2dDS.setContactors()
              • RigidBody2dDS.base_position()
            • SiconosCollisionQueryResult
              • SiconosCollisionQueryResult.distance
              • SiconosCollisionQueryResult.body
              • SiconosCollisionQueryResult.shape
              • SiconosCollisionQueryResult.contactor
              • SiconosCollisionQueryResult.point
            • 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
              • btQuadWord.getX()
              • btQuadWord.getY()
              • btQuadWord.getZ()
              • btQuadWord.setX()
              • btQuadWord.setY()
              • btQuadWord.setZ()
              • btQuadWord.setW()
              • btQuadWord.x()
              • btQuadWord.y()
              • btQuadWord.z()
              • btQuadWord.w()
              • btQuadWord.setValue()
              • btQuadWord.setMax()
              • btQuadWord.setMin()
            • 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()
            • btTransform_getIdentity()
            • btTransformFloatData
            • btDefaultCollisionConfiguration
              • btDefaultCollisionConfiguration.getPersistentManifoldPool()
              • btDefaultCollisionConfiguration.setConvexConvexMultipointIterations()
            • 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
              • btBroadphaseInterface.calculateOverlappingPairs()
              • btBroadphaseInterface.getBroadphaseAabb()
              • btBroadphaseInterface.resetPool()
            • btCollisionWorld
              • btCollisionWorld.computeOverlappingPairs()
              • btCollisionWorld.rayTest()
              • btCollisionWorld.convexSweepTest()
              • btCollisionWorld.contactTest()
              • btCollisionWorld.contactPairTest()
              • btCollisionWorld.rayTestSingle()
              • btCollisionWorld.objectQuerySingle()
              • btCollisionWorld.serialize()
            • btCollisionWorld_rayTestSingle()
            • btCollisionWorld_objectQuerySingle()
            • btManifoldPoint
              • btManifoldPoint.m_positionWorldOnA
              • btManifoldPoint.getAppliedImpulse()
            • btPersistentManifold
              • btPersistentManifold.setNumContacts()
              • btPersistentManifold.getContactBreakingThreshold()
              • btPersistentManifold.refreshContactPoints()
            • btCollisionShape
              • btCollisionShape.getAabb()
              • btCollisionShape.getAngularMotionDisc()
              • btCollisionShape.calculateTemporalAabb()
              • btCollisionShape.isInfinite()
              • btCollisionShape.getAnisotropicRollingFrictionDirection()
              • btCollisionShape.setUserPointer()
              • btCollisionShape.serialize()
            • btCollisionShapeData
            • btConvexShape
              • btConvexShape.getAabb()
            • btConvexInternalShape
              • btConvexInternalShape.setImplicitShapeDimensions()
              • btConvexInternalShape.getAabb()
              • btConvexInternalShape.serialize()
            • btConvexInternalShapeData
            • btConvexInternalAabbCachingShape
              • btConvexInternalAabbCachingShape.getAabb()
            • btConvex2dShape
              • btConvex2dShape.getAabb()
            • btPolyhedralConvexShape
              • btPolyhedralConvexShape.initializePolyhedralFeatures()
            • btPolyhedralConvexAabbCachingShape
              • btPolyhedralConvexAabbCachingShape.getAabb()
            • btConvexHullShape
              • btConvexHullShape.getPoints()
              • btConvexHullShape.setLocalScaling()
              • btConvexHullShape.serialize()
            • btConvexHullShapeData
            • btConvexPointCloudShape
              • btConvexPointCloudShape.setLocalScaling()
            • TEST_INTERNAL_OBJECTS
            • btConvexTriangleMeshShape
              • btConvexTriangleMeshShape.calculatePrincipalAxisTransform()
            • btConcaveShape
            • btEmptyShape
              • btEmptyShape.getAabb()
            • btCompoundShape
              • btCompoundShape.removeChildShape()
              • btCompoundShape.updateChildTransform()
              • btCompoundShape.getAabb()
              • btCompoundShape.recalculateLocalAabb()
              • btCompoundShape.calculatePrincipalAxisTransform()
              • btCompoundShape.serialize()
            • btCompoundShapeChildData
            • btCompoundShapeData
            • btTriangleShape
              • btTriangleShape.getAabb()
            • btTriangleMesh
              • btTriangleMesh.addTriangle()
              • btTriangleMesh.addTriangleIndices()
              • btTriangleMesh.findOrAddVertex()
              • btTriangleMesh.addIndex()
            • btTriangleMeshShape
              • btTriangleMeshShape.getAabb()
            • btBox2dShape
              • btBox2dShape.getAabb()
            • btBoxShape
              • btBoxShape.getAabb()
            • btCapsuleShape
              • btCapsuleShape.calculateLocalInertia()
              • btCapsuleShape.localGetSupportingVertexWithoutMargin()
              • btCapsuleShape.getAabb()
              • btCapsuleShape.getAnisotropicRollingFrictionDirection()
              • btCapsuleShape.serialize()
            • btCapsuleShapeX
            • btCapsuleShapeData
            • btConeShape
              • btConeShape.setConeUpIndex()
              • btConeShape.getAnisotropicRollingFrictionDirection()
              • btConeShape.serialize()
            • btConeShapeData
            • btCylinderShape
              • btCylinderShape.getAabb()
              • btCylinderShape.getAnisotropicRollingFrictionDirection()
              • btCylinderShape.serialize()
            • btCylinderShapeX
            • btCylinderShapeZ
            • btCylinderShapeData
            • btHeightfieldTerrainShape
              • btHeightfieldTerrainShape.setUseZigzagSubdivision()
              • btHeightfieldTerrainShape.getAabb()
            • btMaterial
            • btMinkowskiSumShape
            • btSphereShape
              • btSphereShape.getAabb()
            • btMultiSphereShape
              • btMultiSphereShape.calculateLocalInertia()
              • btMultiSphereShape.localGetSupportingVertexWithoutMargin()
              • btMultiSphereShape.serialize()
            • btMultimaterialTriangleMeshShape
              • btMultimaterialTriangleMeshShape.getMaterialProperties()
            • btOptimizedBvh
              • btOptimizedBvh.serializeInPlace()
              • btOptimizedBvh.deSerializeInPlace()
            • btOptimizedBvh_deSerializeInPlace()
            • btScaledBvhTriangleMeshShape
              • btScaledBvhTriangleMeshShape.getAabb()
              • btScaledBvhTriangleMeshShape.serialize()
            • btScaledTriangleMeshShapeData
            • btShapeHull
            • btStaticPlaneShape
              • btStaticPlaneShape.getAabb()
              • btStaticPlaneShape.serialize()
            • btStaticPlaneShapeData
            • btStridingMeshInterface
              • btStridingMeshInterface.calculateAabbBruteForce()
              • btStridingMeshInterface.getLockedVertexIndexBase()
              • btStridingMeshInterface.unLockVertexBase()
              • btStridingMeshInterface.getNumSubParts()
              • btStridingMeshInterface.serialize()
            • btMeshPartData
            • btStridingMeshInterfaceData
            • btTriangleBuffer
            • btTriangleCallback
            • btIndexedMesh
            • btTriangleIndexVertexArray
              • btTriangleIndexVertexArray.getLockedVertexIndexBase()
              • btTriangleIndexVertexArray.unLockVertexBase()
              • btTriangleIndexVertexArray.getNumSubParts()
            • btMaterialProperties
              • btMaterialProperties.m_numMaterials
              • btMaterialProperties.m_numTriangles
              • btMaterialProperties.m_triangleType
            • btTriangleIndexVertexMaterialArray
            • TRI_INFO_V0V1_CONVEX
            • btTriangleInfo
            • btTriangleInfoMap
              • btTriangleInfoMap.m_planarEpsilon
              • btTriangleInfoMap.m_equalVertexThreshold
              • btTriangleInfoMap.m_edgeDistanceThreshold
              • btTriangleInfoMap.m_maxEdgeAngleThreshold
              • btTriangleInfoMap.serialize()
            • btTriangleInfoData
            • btUniformScalingShape
              • btUniformScalingShape.getAabb()
            • 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
              • BulletR.display()
            • Bullet1DR
              • Bullet1DR.computeh()
            • Bullet5DR
          • siconos.mechanics.collision.bodies
            • nullDeleter
            • CircularDS
            • CircularR
            • Disk
            • Circle
            • DiskDiskR
              • DiskDiskR.computeh()
              • DiskDiskR.computeJachq()
            • DiskPlanR
              • DiskPlanR.computeh()
              • DiskPlanR.computeJachq()
            • DiskMovingPlanR
              • DiskMovingPlanR.computeh()
              • DiskMovingPlanR.computeJachq()
              • DiskMovingPlanR.computehDot()
              • DiskMovingPlanR.computeA()
              • DiskMovingPlanR.computeB()
              • DiskMovingPlanR.computeC()
              • DiskMovingPlanR.computeADot()
              • DiskMovingPlanR.computeBDot()
              • DiskMovingPlanR.computeCDot()
            • SphereLDS
              • SphereLDS.computeMass()
              • SphereLDS.computeFGyr()
              • SphereLDS.computeJacobianFGyrq()
              • SphereLDS.computeJacobianFGyrqDot()
            • SphereNEDS
            • SphereLDSPlanR
              • SphereLDSPlanR.computeh()
              • SphereLDSPlanR.computeJachq()
            • SphereNEDSPlanR
              • SphereNEDSPlanR.distance()
              • SphereNEDSPlanR.computeh()
            • SphereLDSSphereLDSR
              • SphereLDSSphereLDSR.computeh()
              • SphereLDSSphereLDSR.computeJachq()
            • SphereNEDSSphereNEDSR
              • SphereNEDSSphereNEDSR.distance()
              • SphereNEDSSphereNEDSR.computeh()
          • siconos.mechanics.collision.native
            • nullDeleter
            • SiconosBodies
          • siconos.io.io_base
            • nullDeleter
      • Full documentation
        • Getting and installing siconos software
          • Build and install
            • Overview
            • Installation from sources
              • Prerequisites
              • The quick way
              • Detailed installation
              • Siconos package description
              • Running siconos tests
              • What will be installed?
                • Remark
              • CMake options
                • Most common options
                • Developers or advanced users options
              • User-defined option file
              • Test your installation
            • Repositories
              • Debian bullseye
              • FreeBSD
        • Siconos Quickstart
          • Quickstart
            • What is Siconos?
            • Try it
            • Siconos usage in a few steps
            • More
              • Modeling Principle
              • Python interface : tutorials
                • Collections of rigid bodies with Bullet based contact detection (Siconos/Mechanics)
                  • Description of the physical problems : rigid bodies collection with contact and Coulomb friction
                • Tutorial: A 4-diodes bridge wave rectifier
                  • Preamble
                  • Siconos driver file
                  • Building a nonsmooth dynamical system
                    • Modeling the dynamics
                    • Modeling the interactions
                  • Describing the simulation of the nonsmooth dynamical system
                  • Leading the Simulation Process
              • Siconos tutorials in C++
                • Bouncing Ball
                • Tutorial : a column of three beads
                  • Building the Non-Smooth Dynamical System
                  • The Simulation
                    • Time-Stepping scheme
                    • Event-Driven algorithm
                  • Simulation Process
                    • Time-Stepping
                    • Event-Driven
                  • Results
                • Gene regulatory networks
                • Slider Crank
                  • Usage
              • Simulation of an electrical oscillator supplying a resistor through a half-wave rectifier
                • Description of the physical problem : electrical oscillator with half-wave rectifier
                • Definition of a general abstract class of NSDS : the linear time invariant complementarity system (LCS)
                  • Dynamical system and Boundary conditions
                  • Relation between constrained variables and state variables
                  • Definition of the Non Smooth Law between constrained variables
                  • The formalization of the electrical oscillator with half-wave rectifier into the LCS
                  • Dynamical equation
                  • Relations
                  • Non Smooth laws
                • Description of the numerical simulation: the Moreau’s time-stepping scheme
                  • Time discretization of the dynamical system
                  • Time discretization of the relations
                  • Time discretization of the non-smooth law
                  • Summary of the time discretized equations
                  • Numerical simulation
                • Comparison with numerical results coming from SPICE models and algorithms
                  • Characteristic of the diode in the SPICE model
                  • Simulation results
              • Running a simulation
                • Basics
                • Plugins mechanism
                • Extra source files
              • C++ Refresher
                • Building/destroying and using objects
                • Members/Methods access
                • Matrices and vectors handling
                  • Read/write vectors and matrices from/to file
                  • Methods and operations on matrices and vectors
                  • About efficiency
        • Users’ guide
          • Users guide
            • Linear Algebra in Siconos
              • Vectors
              • Matrices
                • Notes about SimpleMatrix
              • Matrix Storage in numerics component
            • Modeling of non-smooth dynamical systems
              • Dynamical Systems
                • Overview
                • Common interface
                • First order dynamical systems
                  • Non linear
                  • Linear
                  • Linear and time-invariant
                • Second order (Lagrangian) systems
                  • Non linear
                  • Linear and time-invariant
                • Dynamical Systems plug-in functions
              • Interactions between dynamical systems
                • Relations
                  • First Order Relations
                    • Non Linear
                    • Linear
                    • Linear with Time Invariant Coefficients
                  • Lagrangian (second order) Relations
                    • Scleronomous
                    • Rheonomous
                    • Compliant
                    • Linear and Time Invariant Coefficients
                  • Relations plug-in functions
                • Non Smooth Laws
                  • Complementarity Condition
                  • Newton Impact
                  • Newton Impact-Friction
                  • Relay
              • User-defined plugins
                • Plugins overview
                • Example
            • Simulation of non-smooth dynamical systems
              • Time discretisation
              • Time integration of the dynamics
              • Event-Capturing schemes
                • General Principle
                • First order systems
                  • Time Discretisation of the Dynamics
                    • First Order Non Linear Systems
                    • First Order Linear Systems
                    • First Order Linear Systems with time invariant coefficients
                  • Time discretization of the relations
                    • First Order (non-linear) Relations
                    • First Order Linear Relations
                  • Discretisation of the non-smooth law
                    • Complementarity Condition
                • Lagrangian systems
                  • Time Discretisation of the Dynamics
                    • Lagrangian (second order) Non Linear Systems
                    • Lagrangian (second order) Linear Systems with Time Invariant coefficients
                  • Time discretization of the relations
                    • Lagrangian Scleronomous Relations
                    • Lagrangian Rheonomous Relations
                    • Lagrangian Compliant Relations
                    • Lagrangian Linear Relations
                  • Time discretization of the Non Smooth laws
                • Summary of the time discretized equations
                  • First order systems
                  • Lagrangian second-order systems
              • Event-Driven schemes
                • General Principle
                • Event Driven implementation
                  • Integration of the smooth dynamics
                  • Events
                  • The Events manager
                • The Simulation process
                • Event Driven algorithm for Lagrangian systems
                  • The impact equations
                  • The smooth Dynamics
                • The algorithm
                  • Implementation in Siconos
              • Nonsmooth problems formulation and solve
                • The Simulation process
                • Customize simulation behavior
            • Nonsmooth problems formulations and available solvers
              • Write and solve a problem with Siconos
                • Create a problem
                • Create and describe a solver
                  • dparam indices common to all solvers
                  • iparam indices common to all solvers
                • Solve a problem
                  • Variational Inequality (VI)
                    • Problem statement
                    • Implementation in numerics
                    • VI Available solvers
                      • Extra gradient (SICONOS_VI_EG)
                      • Fixed-point projection (SICONOS_VI_FPP)
                      • Hyperplane projection (SICONOS_VI_HP)
                      • SICONOS_VI_BOX_QI (SICONOS_VI_BOX_QI)
                      • SICONOS_VI_BOX_AVI_LSA (SICONOS_VI_BOX_AVI_LSA)
                      • SICONOS_VI_BOX_PATH (SICONOS_VI_BOX_PATH)
                  • Quadratic Programming problems (QP)
                    • Problem statement
                    • Available solvers
                  • Convex Quadratic Programming (ConvexQP) problems
                    • Problem statement
                    • Implementation in numerics
                    • Available solvers
                      • convex QP, projected gradient (SICONOS_CONVEXQP_PG)
                      • convex QP, VI solvers`(SICONOS_CONVEXQP_VI_FPP and SICONOS_CONVEXQP_VI_EG)
                      • convex QP, ADMM (SICONOS_CONVEXQP_ADMM)
                  • Linear Complementarity Problems (LCP)
                    • Problem statement
                    • Implementation in numerics
                    • Error computation
                    • LCP available solvers
                      • Direct solvers
                        • Lemke (SICONOS_LCP_LEMKE)
                        • Pivot based methods
                        • Enumerative solver (SICONOS_LCP_ENUM)
                        • PATH (SICONOS_LCP_PATH)
                      • Iterative solvers
                        • Conjugated Projected Gradient (SICONOS_LCP_CPG)
                        • Projected Gauss-Seidel (SICONOS_LCP_PGS)
                        • Regularized Projected Gauss-Seidel (SICONOS_LCP_RPGS)
                        • PSOR (SICONOS_LCP_PSOR)
                        • Latin method (SICONOS_LCP_LATIN and SICONOS_LCP_LATIN_W)
                        • Sparse-block Gauss-Seidel (SICONOS_LCP_NSGS)
                      • Equation-based solvers
                        • Nonsmooth Newton, min formulation (SICONOS_LCP_NEWTONMIN)
                        • Nonsmooth Newton, Fisher-Burmeister (SICONOS_LCP_NEWTON_FB_FBLSA)
                        • Nonsmooth Newton, Fisher-Burmeister (SICONOS_LCP_NEWTON_MIN_FBLSA)
                        • GAMS solver (SICONOS_LCP_GAMS)
                      • QP-reformulation
                        • quadratic program formulation (SICONOS_LCP_QP)
                        • quadratic program formulation (SICONOS_LCP_NSQP)
                      • AVI reformulation
                        • AVI with Cao/Ferris solver (SICONOS_AVI_CAOFERRIS)
                  • Affine Variational Inequalities (AVI)
                    • Problem statement
                    • Implementation in numerics
                    • AVI Available solvers
                      • Cao Ferris (SICONOS_AVI_CAOFERRIS)
                      • Pathvi (SICONOS_AVI_PATHAVI)
                  • Mixed (Non Linear) Complementarity problem (MCP)
                    • Problem statement
                    • Implementation in numerics
                    • MCP available solvers
                      • Newton, Fisher-Burmeister (SICONOS_MCP_NEWTON_FB_FBLSA)
                      • Newton (min), Fisher-Burmeister (SICONOS_MCP_NEWTON_MIN_FB_FBLSA)
                      • Newton, Fisher-Burmeister (SICONOS_MCP_OLD_FB)
                  • Mixed Linear Complementarity Problems (MLCP)
                    • Problem statement
                    • Implementation in numerics
                    • Error computation
                    • MLCP available solvers
                      • Projected Gauss-Seidel (SICONOS_MLCP_PGS)
                      • Projected Gauss-Seidel, SBM (SICONOS_MLCP_PGS_SBM)
                      • Regularized Projected Gauss-Seidel (SICONOS_MLCP_RPGS)
                      • PSOR (SICONOS_MLCP_PSOR)
                      • RPSOR (SICONOS_MLCP_RPSOR)
                      • PATH (Ferris) solver (SICONOS_MLCP_PATH)
                      • Enumerative solver (SICONOS_MLCP_ENUM)
                      • PATH + enum solver (SICONOS_MLCP_PATH_ENUM)
                      • Direct + enum solver (SICONOS_MLCP_DIRECT_ENUM)
                      • Simplex solver (SICONOS_MLCP_SIMPLEX)
                      • Direct/Simplex solver (SICONOS_MLCP_DIRECT_SIMPLEX)
                      • Direct/Path solver (SICONOS_MLCP_DIRECT_PATH)
                      • Direct/Path/enum solver (SICONOS_MLCP_DIRECT_PATH_ENUM)
                      • Nonsmooth Newton solver, Fisher-Burmeister (SICONOS_MLCP_FB)
                      • Direct + Nonsmooth Newton solver, Fisher-Burmeister (SICONOS_MLCP_DIRECT_FB)
                  • Nonlinear Complementarity Problems (NCP)
                    • Problem statement
                    • Implementation in numerics
                    • NCP available solvers
                      • Newton, Fisher-Burmeister (SICONOS_NCP_NEWTON_FB_FBLSA)
                      • Newton, min merit function (SICONOS_NCP_NEWTON_MIN_FBLSA)
                      • Path search algorithm (SICONOS_NCP_PATHSEARCH)
                      • PATH (Ferris) solver (SICONOS_NCP_PATH)
                  • Relay or box-constrained AVI problems
                    • Problem statement
                    • Implementation in numerics
                    • Relay available solvers
                      • Direct solvers
                        • Enumerative solver (SICONOS_RELAY_ENUM)
                        • Lemke solver (SICONOS_RELAY_LEMKE)
                        • PATH (SICONOS_RELAY_PATH)
                      • AVI reformulation
                        • AVI, Cao/Ferris solver (SICONOS_RELAY_AVI_CAOFERRIS)
                      • Iterative solvers
                        • Projected Gauss-Seidel (SICONOS_RELAY_PGS)
                  • Second Order Cone Linear Complementarity Problem (SOCLCP)
                    • Problem statement
                    • Implementation in numerics
                    • SOCLCP available solvers
                      • Gauss-Seidel (SICONOS_SOCLCP_NSGS)
                      • VI, fixed-point (SICONOS_SOCLCP_VI_FPP)
                      • VI, Extra-gradient (SICONOS_SOCLCP_VI_EG)
                      • VI, Extra-gradient (SICONOS_SOCLCP_VI_EG)
                      • Projections
                  • Friction-contact problems (2 or 3D)
                    • Problem statement
                    • Implementation in numerics
                    • Error strategy
                    • Friction 2D available solvers
                      • Nonsmooth Gauss-Seidel (SICONOS_FRICTION_2D_NSGS)
                      • Conjugated projected gradient (SICONOS_FRICTION_2D_CPG)
                      • Lemke solver (SICONOS_FRICTION_2D_LEMKE)
                      • Enumerative solver (SICONOS_FRICTION_2D_ENUM)
                    • Friction 3D available solvers
                      • Nonsmooth Gauss-Seidel (SICONOS_FRICTION_3D_NSGS)
                      • Nonsmooth Gauss-Seidel, velocity version (SICONOS_FRICTION_3D_NSGSV)
                      • Proximal point solver (SICONOS_FRICTION_3D_PROX)
                      • Fixed-point (Tresca) (SICONOS_FRICTION_3D_TFP)
                      • Nonsmooth Newton/ Alart-Curnier (SICONOS_FRICTION_3D_NSN_AC)
                      • Nonsmooth Newton/ Alart-Curnier (test) (SICONOS_FRICTION_3D_NSN_AC_TEST)
                      • Fixed-Point (De Saxce formulation) (SICONOS_FRICTION_3D_DSFP)
                      • Fixed-Point projection (VI reformulation) (SICONOS_FRICTION_3D_VI_FPP)
                      • Fixed-Point projection on cylinder (VI reformulation) (SICONOS_FRICTION_3D_VI_FPP_Cylinder)
                      • Extra Gradient (VI reformulation) (SICONOS_FRICTION_3D_VI_EG)
                      • Hyperplane Projection (SICONOS_FRICTION_3D_HP)
                      • Fixed-Point projection (SICONOS_FRICTION_3D_FPP)
                      • Extra Gradient (SICONOS_FRICTION_3D_EG)
                      • Nonsmooth Newton (Fischer-Burmeister formulation) (SICONOS_FRICTION_3D_NSN_FB)
                      • PATH (via GAMS) + AVI reformulation (SICONOS_FRICTION_3D_GAMS_PATH)
                      • PATHVI (via GAMS) + AVI reformulation SICONOS_FRICTION_3D_GAMS_PATHVI)
                      • Nonsmooth Gauss-Seidel (SICONOS_FRICTION_3D_SOCLCP)
                      • PATH (via GAMS) + LCP reformulation (SICONOS_FRICTION_3D_GAMS_LCP_PATH)
                      • PATHVI (via GAMS) + LCP reformulation SICONOS_FRICTION_3D_GAMS_LCP_PATHVI)
                      • Nonsmooth Newton, Natural Map (SICONOS_FRICTION_3D_NSN_NM)
                      • Fixed point, Panagiotopoulos (SICONOS_FRICTION_3D_PFP)
                      • ADMM (SICONOS_FRICTION_3D_ADMM)
                        • “One contact” solvers
                      • Newton(SICONOS_FRICTION_3D_ONECONTACT_NSN, …)
                      • Projection on cone or cylinder (SICONOS_FRICTION_3D_ONECONTACT_ProjectionOnCone, …)
                      • NCP Fixed Point solver (SICONOS_FRICTION_3D_NCPGlockerFBFixedPoint, …)
                      • Quartic (SICONOS_FRICTION_3D_ONECONTACT_QUARTIC, …)
                      • As Convex QP (SICONOS_FRICTION_3D_CONVEXQP_CYLINDER)
                  • Global-Friction-contact problems (2D or 3D)
                    • Problem statement
                    • Implementation in numerics
                    • Error strategy
                    • Global Friction 3D available solvers
                      • NSGS (SICONOS_GLOBAL_FRICTION_3D_NSGS)
                      • Nonsmooth Newton, Alart-Curnier, (SICONOS_GLOBAL_FRICTION_3D_NSN_AC)
                      • PATH (GAMS) (SICONOS_GLOBAL_FRICTION_3D_GAMS_PATH)
                      • PATHVI (GAMS) (SICONOS_GLOBAL_FRICTION_3D_GAMS_PATHVI)
                      • Fixed-Point projection (VI reformulation) (SICONOS_GLOBAL_FRICTION_3D_VI_FPP)
                      • Extra-Gradient (VI reformulation) (SICONOS_GLOBAL_FRICTION_3D_VI_EG)
                      • ACLM Fixed point (SICONOS_GLOBAL_FRICTION_3D_ACLMFP)
                      • ADMM (SICONOS_GLOBAL_FRICTION_3D_ADMM)
                        • Solvers with reformulation
                      • NSGS, with reformulation (SICONOS_GLOBAL_FRICTION_3D_NSGS_WR)
                      • NSGS, velocity, with reformulation (SICONOS_GLOBAL_FRICTION_3D_NSGS_WR)
                      • Proximal point, with reformulation (SICONOS_GLOBAL_FRICTION_3D_PROX_WR)
                      • DeSaxce FixedPoint, with reformulation (SICONOS_GLOBAL_FRICTION_3D_DSFP_WR)
                      • Tresca FixedPoint, with reformulation (SICONOS_GLOBAL_FRICTION_3D_TFP_WR)
                      • Nonsmooth Newton, Alart-Curnier, with reformulation (SICONOS_GLOBAL_FRICTION_3D_NSN_AC_WR)
                      • ADMM, with reformulation (SICONOS_GLOBAL_FRICTION_3D_ADMM_WR)
                  • Rolling friction-contact problems
                    • Problem statement
                    • Implementation in numerics
                    • Error strategy
                    • Rolling-Friction 3D available solvers
                      • NSGS (SICONOS_ROLLING_FRICTION_3D_NSGS)
                      • Projection on cone (SICONOS_ROLLING_FRICTION_3D_ONECONTACT_ProjectionOnCone, …)
                  • Generic mechanical problems
                    • Problem statement
                    • Implementation in numerics
                    • Error strategy
                    • GMP solvers
            • Control Toolbox
              • Control Manager
              • Sensors
              • Actuators
          • Browse examples
            • Gallery
        • Siconos API
          • API reference
            • Siconos C/C++ API reference
              • 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.
                • Classes and structs
                • Files documentation
              • Kernel: high-level API to modelise and simulate nonsmooth dynamical systems.
                • Classes and structs
                • Files documentation
              • Control: control toolbox
                • Classes and structs
                • Files documentation
              • Mechanics: toolbox for collision detection and joints
                • Classes and structs
                • Files documentation
              • Io: tools related to input/outputs (hdf5, vtk …)
                • Classes and structs
                • Files documentation
            • Siconos Python API reference
              • 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
                  • Callback.env
                  • Callback.collectStatsIteration
                • 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_factors.n
                  • CSparseMatrix_factors.S
                  • CSparseMatrix_factors.N
                • 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
                  • SparseBlockStructuredMatrix.version
                • 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
                  • NumericsMatrix.storageType
                  • NumericsMatrix.size0
                  • NumericsMatrix.size1
                  • NumericsMatrix.matrix0
                  • NumericsMatrix.matrix1
                  • NumericsMatrix.matrix2
                  • NumericsMatrix.internalData
                  • NumericsMatrix.destructible
                • 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
                  • NSM_linear_solver_params.linear_solver_data
                  • NSM_linear_solver_params.solver_free_hook
                  • NSM_linear_solver_params.iWork
                  • NSM_linear_solver_params.iWorkSize
                  • NSM_linear_solver_params.linalg_data
                • NumericsSparseMatrix
                  • NumericsSparseMatrix.triplet
                  • NumericsSparseMatrix.half_triplet
                  • NumericsSparseMatrix.csc
                  • NumericsSparseMatrix.trans_csc
                  • NumericsSparseMatrix.csr
                  • NumericsSparseMatrix.diag_indx
                  • NumericsSparseMatrix.origin
                  • NumericsSparseMatrix.linearSolverParams
                • 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_max_version()
                • NSM_set_version()
                • NSM_reset_versions()
                • NSM_reset_version()
                • NSM_inc_version()
                • NSM_latest_id()
                • NSM_latest()
                • NSM_version_sync()
                • NM_MUMPS_copy()
                • MLCP
                  • MLCP.isStorageType1
                  • MLCP.isStorageType2
                  • MLCP.n
                  • MLCP.m
                  • MLCP.blocksRows
                  • MLCP.blocksIsComp
                  • MLCP.M
                  • MLCP.q
                  • MLCP.A
                  • MLCP.B
                  • MLCP.C
                  • MLCP.D
                  • MLCP.a
                  • MLCP.b
                • 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
                  • LCP.size
                  • LCP.M
                  • LCP.q
                • 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.size
                  • AVI.M
                  • AVI.q
                  • AVI.d
                  • AVI.poly
                  • AVI.lb
                  • AVI.ub
                  • AVI.cones
                • 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.n1
                  • MCP.n2
                  • MCP.compute_Fmcp
                  • MCP.compute_nabla_Fmcp
                  • MCP.nabla_Fmcp
                  • MCP.env
                • MCP_old
                  • MCP_old.sizeEqualities
                  • MCP_old.sizeInequalities
                  • MCP_old.computeFmcp
                  • MCP_old.Fmcp
                  • MCP_old.nablaFmcp
                • 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
                  • NCP.n
                  • NCP.compute_F
                  • NCP.compute_nabla_F
                  • NCP.nabla_F
                  • NCP.env
                • 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.n
                  • SecondOrderConeLinearComplementarityProblem.nc
                  • SecondOrderConeLinearComplementarityProblem.M
                  • SecondOrderConeLinearComplementarityProblem.q
                  • SecondOrderConeLinearComplementarityProblem.coneIndex
                  • SecondOrderConeLinearComplementarityProblem.tau
                • 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.dimension
                  • FrictionContactProblem.numberOfContacts
                  • FrictionContactProblem.M
                  • FrictionContactProblem.q
                  • FrictionContactProblem.mu
                • 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_int.name
                  • GAMS_opt_int.value
                  • GAMS_opt_int.type
                  • GAMS_opt_int.next_opt
                • GAMS_opt_double
                  • GAMS_opt_double.name
                  • GAMS_opt_double.value
                  • GAMS_opt_double.type
                  • GAMS_opt_double.next_opt
                • GAMS_opt_str
                  • GAMS_opt_str.name
                  • GAMS_opt_str.value
                  • GAMS_opt_str.type
                  • GAMS_opt_str.next_opt
                • SN_GAMSparams
                  • SN_GAMSparams.model_dir
                  • SN_GAMSparams.gams_dir
                  • SN_GAMSparams.filename
                  • SN_GAMSparams.filename_suffix
                  • SN_GAMSparams.opt_str_list
                  • SN_GAMSparams.opt_bool_list
                  • SN_GAMSparams.opt_int_list
                  • SN_GAMSparams.opt_double_list
                • 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.dimension
                  • RollingFrictionContactProblem.numberOfContacts
                  • RollingFrictionContactProblem.M
                  • RollingFrictionContactProblem.q
                  • RollingFrictionContactProblem.mu
                  • RollingFrictionContactProblem.mu_r
                • 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.randomize_sym()
                  • 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.randomize_sym()
                  • 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()