diff --git a/CMakeLists.txt b/CMakeLists.txt
index 542e105..ccc8429 100644
--- a/CMakeLists.txt
+++ b/CMakeLists.txt
@@ -1,274 +1,278 @@
 project(specmicp)
 cmake_minimum_required(VERSION 2.8.8)
 
 # Options :
 #  - SPECMICP_USE_OPENMP : bool : use openmp to parallelize code
 #
 #
 
 #######################  External Package #####################################
 set(CMAKE_MODULE_PATH ${CMAKE_MODULE_PATH} "${PROJECT_SOURCE_DIR}/cmake/")
 find_package(Boost REQUIRED)
 include_directories(${Boost_INCLUDE_DIR})
 find_package(Eigen3 REQUIRED)  # This module comes from the Eigen3 Package
 include_directories(${EIGEN3_INCLUDE_DIR})
 
+if(EXISTS "${EIGEN3_INCLUDE_DIR}/unsupported/Eigen/src/IterativeSolvers/GMRES.h")
+    add_definitions(-DEIGEN_UNSUPPORTED_FOUND)
+    INCLUDE_DIRECTORIES("${EIGEN3_INCLUDE_DIR}/unsupported/")
+endif()
 ########################  Compilation flags #################################
 if(UNIX)
    SET(CMAKE_CXX_FLAGS "${CMAKE_CXX_FLAGS} -march=native -std=c++11 -fuse-ld=gold")
    SET(CMAKE_CXX_FLAGS_DEBUG "${CMAKE_CXX_FLAGS_DEBUG} -Wall -pedantic")
    SET(CMAKE_CXX_FLAGS_RELEASE "${CMAKE_CXX_FLAGS_RELEASE} -O2 -DNDEBUG")
    if(SPECMICP_USE_OPENMP)
         SET(CMAKE_CXX_FLAGS "${CMAKE_CXX_FLAGS}  -fopenmp")
         add_definitions(-DSPECMICP_USE_OPENMP)
    endif()
    message(STATUS "c++ flags ${CMAKE_CXX_FLAGS}")
 else()
     message(WARNING "not tested !")
 endif()
 
 
 ################ Directories #####################
 # 3rd party
 
 set(JSONCPP_DIR  ${PROJECT_SOURCE_DIR}/3rdparty/jsoncpp/)
 
 add_custom_target(3rdparty_header SOURCES
     ${JSONCPP_DIR}/json/json.h
     ${JSONCPP_DIR}/json/json-forwards.h
 )
 include_directories(${PROJECT_SOURCE_DIR}/3rdparty/jsoncpp/)
 
 set(PROJECT_SOURCE_DIR ${CMAKE_CURRENT_SOURCE_DIR}/src)
 # include
 include_directories(${PROJECT_SOURCE_DIR})
 
 add_custom_target(common SOURCES
     ${PROJECT_SOURCE_DIR}/common.hpp
     ${PROJECT_SOURCE_DIR}/database.hpp
 )
 
 ################ Modules ##########################
 
 # -------- MiCPSolver ----------------
 
 set(MICPSOLVER_DIR ${PROJECT_SOURCE_DIR}/micpsolver)
 
 add_custom_target(specmisolver_inc SOURCES
     ${MICPSOLVER_DIR}/micpsolver_base.hpp
     ${MICPSOLVER_DIR}/micpsolver_base.inl
     ${MICPSOLVER_DIR}/micpsolver.hpp
     ${MICPSOLVER_DIR}/micpsolver.inl
     ${MICPSOLVER_DIR}/micpsolver_min.hpp
     ${MICPSOLVER_DIR}/micpsolver_min.inl
     ${MICPSOLVER_DIR}/micpsolverold.hpp
     ${MICPSOLVER_DIR}/micpsolverold.inl
     ${MICPSOLVER_DIR}/micpsolver_structs.hpp
     ${MICPSOLVER_DIR}/micpprog.hpp
     ${MICPSOLVER_DIR}/ncp_function.hpp
     ${MICPSOLVER_DIR}/estimate_cond_number.hpp
 )
 
 # ------- SpecMiCP ---------------
 
 set(SPECMICP_DIR ${PROJECT_SOURCE_DIR}/specmicp)
 set(KINETICS_DIR ${SPECMICP_DIR}/kinetics)
 
 add_custom_target(specmic_inc SOURCES
     #${SPECMICP_DIR}/.hpp
     ${SPECMICP_DIR}/simulation_box.hpp
     ${SPECMICP_DIR}/reduced_system_solver_structs.hpp
     ${KINETICS_DIR}/kinetic_model.hpp
     ${KINETICS_DIR}/kinetic_variables.hpp
     ${KINETICS_DIR}/kinetic_system_solver_structs.hpp
 )
 
 set(SPECMICP_LIBFILE
     ${SPECMICP_DIR}/equilibrium_data.cpp
     ${SPECMICP_DIR}/reduced_system.cpp
     ${SPECMICP_DIR}/reduced_system_solver.cpp
     ${SPECMICP_DIR}/reaction_path.cpp
     #${SPECMICP_DIR}/speciation_solver.cpp
     #${SPECMICP_DIR}/simple_composition.cpp
 
     # kinetic
     ${KINETICS_DIR}/kinetic_system.cpp
     ${KINETICS_DIR}/kinetic_system_solver.cpp
 )
 
 add_library(specmicp ${SPECMICP_LIBFILE})
 
 # -------- Database ----------------
 
 set(DATABASE_DIR ${PROJECT_SOURCE_DIR}/database)
 
 set(DATABASE_LIBFILE
     ${DATABASE_DIR}/data_container.cpp
     ${DATABASE_DIR}/database.cpp
     ${DATABASE_DIR}/reader.cpp
     ${DATABASE_DIR}/selector.cpp
     ${DATABASE_DIR}/mineral_selector.cpp
     ${DATABASE_DIR}/canonicalizer.cpp
     ${DATABASE_DIR}/switch_basis.cpp
 
     ${JSONCPP_DIR}/jsoncpp.cpp
 )
 
 add_custom_target(data_incl SOURCES
     ${DATABASE_DIR}/common_def.hpp
     ${DATABASE_DIR}/module.hpp
 )
 
 add_library(specmicp_database ${DATABASE_LIBFILE})
 
 # --------- ODE int ------------------
 
 set(ODEINT_DIR ${PROJECT_SOURCE_DIR}/odeint)
 
 
 add_custom_target(odeint_incl SOURCES
     ${ODEINT_DIR}/odeint_types.hpp
     ${ODEINT_DIR}/butcher_tableau.hpp
     ${ODEINT_DIR}/runge_kutta_step.hpp
     ${ODEINT_DIR}/runge_kutta_step.inl
     ${ODEINT_DIR}/runge_kutta_step_structs.hpp
 )
 
 # --------- DFPMSolver -----------------
 
 set(DFPMSOLVER_DIR ${PROJECT_SOURCE_DIR}/dfpmsolver)
 
 add_custom_target(dfpmsolver_incl SOURCES
     ${DFPMSOLVER_DIR}/driver.hpp
     ${DFPMSOLVER_DIR}/driver.inl
     ${DFPMSOLVER_DIR}/driver_structs.hpp
     ${DFPMSOLVER_DIR}/dfpm_program.hpp
     #
     # Parabolic solver
     ${DFPMSOLVER_DIR}/parabolic_driver.hpp
     ${DFPMSOLVER_DIR}/parabolic_driver.inl
     ${DFPMSOLVER_DIR}/parabolic_program.hpp
     ${DFPMSOLVER_DIR}/parabolic_structs.hpp
 )
 
 # --------- ReactMiCP -----------------
 
 set(REACTMICP_DIR ${PROJECT_SOURCE_DIR}/reactmicp)
 
 add_custom_target(reactmicp_incl SOURCES
     ${REACTMICP_DIR}/common.hpp
     #
     ${REACTMICP_DIR}/micpsolvers/parabolicprogram.hpp
     ${REACTMICP_DIR}/micpsolvers/micpsolver_structs.hpp
     ${REACTMICP_DIR}/micpsolvers/micpsolver.hpp
     ${REACTMICP_DIR}/micpsolvers/micpsolver.inl
     #
 
     ${REACTMICP_DIR}/mesh.hpp
     ${REACTMICP_DIR}/meshes/mesh1dfwd.hpp
     ${REACTMICP_DIR}/meshes/mesh1d.hpp
     ${REACTMICP_DIR}/meshes/uniform_mesh1d.hpp
     ${REACTMICP_DIR}/meshes/axisymmetric_uniform_mesh1d.hpp
 
 
     ${REACTMICP_DIR}/systems/secondary_variables/secondary.hpp
     ${REACTMICP_DIR}/systems/secondary_variables/secondary.inl
 
     ${REACTMICP_DIR}/systems/saturated_diffusion/reactive_transport_solver_structs.hpp
     ${REACTMICP_DIR}/systems/saturated_diffusion/transport_parameters.hpp
     ${REACTMICP_DIR}/systems/saturated_diffusion/transport_parameters_base.hpp
     ${REACTMICP_DIR}/systems/saturated_diffusion/transport_neutrality_parameters.hpp
     ${REACTMICP_DIR}/systems/saturated_diffusion/boundary_conditions.hpp
 )
 
 set(REACTMICP_LIBFILES
     ${REACTMICP_DIR}/systems/diffusion/diffusion.cpp
     ${REACTMICP_DIR}/systems/diffusion/diffusion_numbering.cpp
     ${REACTMICP_DIR}/systems/diffusion/diffusion_secondary.cpp
 
     ${REACTMICP_DIR}/systems/saturated_diffusion/reactive_transport_solver.cpp
     ${REACTMICP_DIR}/systems/saturated_diffusion/reactive_transport_neutrality_solver.cpp
     ${REACTMICP_DIR}/systems/saturated_diffusion/transport_program.cpp
     ${REACTMICP_DIR}/systems/saturated_diffusion/transport_neutrality_program.cpp
     ${REACTMICP_DIR}/systems/saturated_diffusion/transport_neutrality_variables.cpp
     ${REACTMICP_DIR}/systems/saturated_diffusion/variables.cpp
 )
 
 add_library(reactmicp ${REACTMICP_LIBFILES})
 
 # ------- Utils ------------------
 
 set(UTILS_DIR ${PROJECT_SOURCE_DIR}/utils)
 
 add_custom_target(utils_inc SOURCES
     ${UTILS_DIR}/log.hpp
 
     ${UTILS_DIR}/sparse_solver.hpp
     ${UTILS_DIR}/sparse_solver_structs.hpp
 
     ${UTILS_DIR}/options_handler.hpp
     ${UTILS_DIR}/perfs_handler.hpp
 )
 
 # ------- Physics ----------------
 
 set(PHYSICS_DIR ${PROJECT_SOURCE_DIR}/physics)
 
 add_custom_target(physics_inc SOURCES
     ${PHYSICS_DIR}/constants.hpp
     ${PHYSICS_DIR}/laws.hpp
     ${PHYSICS_DIR}/units.hpp
 )
 
 # ------- Data -------------------
 
 set(DATA_DIR ${CMAKE_CURRENT_SOURCE_DIR}/data)
 
 set(DATABASE_LIST
         ${DATA_DIR}/specmicp_database.js
         ${DATA_DIR}/cemdata_specmicp.js
 )
 
 add_custom_target(data SOURCES ${DATABASE_LIST})
 
 file(INSTALL ${DATABASE_LIST}
      DESTINATION ${CMAKE_CURRENT_BINARY_DIR}/data/)
 
 # ------ Documentation -----------
 
 set(
     DOCS_LIST
     ${CMAKE_CURRENT_SOURCE_DIR}/README.md
     ${CMAKE_CURRENT_SOURCE_DIR}/INSTALL
     ${CMAKE_CURRENT_SOURCE_DIR}/TODO
     ${CMAKE_CURRENT_SOURCE_DIR}/COPYING
 )
 
 add_custom_target(docs SOURCES ${DOCS_LIST})
 
 # add a target to generate API documentation with Doxygen
 find_package(Doxygen)
 if(DOXYGEN_FOUND)
 configure_file(${CMAKE_CURRENT_SOURCE_DIR}/doc/Doxyfile.in ${CMAKE_CURRENT_BINARY_DIR}/doc/Doxyfile @ONLY)
 add_custom_target(doc
 ${DOXYGEN_EXECUTABLE} ${CMAKE_CURRENT_BINARY_DIR}/doc/Doxyfile
 WORKING_DIRECTORY ${CMAKE_CURRENT_BINARY_DIR}
 COMMENT "Generating API documentation with Doxygen" VERBATIM
 )
 add_custom_target(citations SOURCES ${CMAKE_CURRENT_SOURCE_DIR}/doc/citations.bib)
 file(INSTALL ${CMAKE_CURRENT_SOURCE_DIR}/doc/citations.bib
      DESTINATION ${CMAKE_CURRENT_BINARY_DIR}/doc/)
 endif(DOXYGEN_FOUND)
 
 # --------- Python interface ----------
 
 add_subdirectory( cython )
 
 
 # --------- Test ----------------------
 
 add_subdirectory( tests )
 
 # --------- Examples ------------------
 
 add_subdirectory( examples )
diff --git a/src/utils/sparse_solver.hpp b/src/utils/sparse_solver.hpp
index 30015fd..b94fbe2 100644
--- a/src/utils/sparse_solver.hpp
+++ b/src/utils/sparse_solver.hpp
@@ -1,182 +1,214 @@
 #ifndef SPECMICP_UTILS_SPARSESOLVER_HPP
 #define SPECMICP_UTILS_SPARSESOLVER_HPP
 
 #include <Eigen/Sparse>
+#ifdef EIGEN_UNSUPPORTED_FOUND
+    #include <iostream>
+    #include <Eigen/IterativeSolvers>
+#endif
 
 #include "sparse_solver_structs.hpp"
 
+
 namespace specmicp {
 
 // header
 // ======
 
 //! \brief Solve a sparse linear system
 template <class DerivedV1, class DerivedV2, class DerivedM>
 SparseSolverReturnCode solve_sparse_linear_system(
         DerivedV1& residual,
         DerivedM& jacobian,
         DerivedV2& update,
         SparseSolver solver
         );
 
 
 //! \brief Solve a sparse linear system using the QR decomposition
 template <class DerivedV1, class DerivedV2, class DerivedM>
 SparseSolverReturnCode solve_linear_system_sparseqr(
         DerivedV1& residual,
         DerivedM& jacobian,
         DerivedV2& update
         );
 
 
 //! \brief Solve a sparse linear system using the LU decomposition
 template <class DerivedV1, class DerivedV2, class DerivedM>
 SparseSolverReturnCode solve_linear_system_sparselu(
         DerivedV1& residual,
         DerivedM& jacobian,
         DerivedV2& update
         );
 
 
 //! \brief Solve a sparse linear system using the BiCGSTAB algorithm
 template <class DerivedV1, class DerivedV2, class DerivedM>
 SparseSolverReturnCode solve_linear_system_bicgstab(
         DerivedV1& residual,
         DerivedM& jacobian,
         DerivedV2& update
         );
 
+
+//! \brief Solve a sparse linear system using the BiCGSTAB algorithm
+template <class DerivedV1, class DerivedV2, class DerivedM>
+SparseSolverReturnCode solve_linear_system_gmres(
+        DerivedV1& residual,
+        DerivedM& jacobian,
+        DerivedV2& update
+        );
+
+
+
 //! \brief A sparse system solver
 template <class SolverType>
 class SparseSystemSolver
 {
 public:
     //! \brief Type of the matrix;
     using MatrixType = typename SolverType::MatrixType;
 
     //! \brief Analyse the sparsity matrix of the jacobian
     void analyse_sparsity() {
         m_solver.analysePattern(m_jacobian);
         m_structure_is_known = true;
     }
 
     //! \brief Compute the decomposition of the jacobian (if available)
     SparseSolverReturnCode compute();
 
     //! \brief Solve the problem, using 'rhs' and storing solution in 'solution'
     template <class RHSType, class UpdateType>
     SparseSolverReturnCode solve(const RHSType& rhs, UpdateType& solution);
 
     //! \brief Return a reference to the jacobian, so it can be updated
     MatrixType& jacobian() {
         m_jacobian_has_changed=true;
         return m_jacobian;
     }
     //! \brief Const reference to the jacobian
     const MatrixType& jacobian() const {return m_jacobian;}
 
 private:
     bool m_structure_is_known;   //!< True if the structure of the jacobian is known
     bool m_jacobian_has_changed; //!< True if the jacobian has changed
     MatrixType m_jacobian;       //!< The jacobian
     SolverType m_solver;         //!< The solver
 };
 
 // Implementation
 // ==============
 
 template <class SolverType>
 SparseSolverReturnCode SparseSystemSolver<SolverType>::compute()
 {
     // first compress the matrix to avoid copy
     if (not m_jacobian.isCompressed()) m_jacobian.makeCompressed();
     if (m_structure_is_known)
         m_solver.factorize(m_jacobian);
     else
         m_solver.compute(m_jacobian);
     if (m_solver.info() != Eigen::Success)
         return SparseSolverReturnCode::FailedDecomposition;
     return SparseSolverReturnCode::Success;
 }
 
 template <class SolverType>
 template <class RHSType, class UpdateType>
 SparseSolverReturnCode SparseSystemSolver<SolverType>::solve(const RHSType& rhs, UpdateType& solution)
 {
     if (m_jacobian_has_changed) compute();
     solution = m_solver.solve(rhs);
     if (m_solver.info() != Eigen::Success)
         return SparseSolverReturnCode::FailedSystemSolving;
     return SparseSolverReturnCode::Success;
 
 }
 
 
 // Implementation
 // ==============
 
 template <class DerivedV1, class DerivedV2, class DerivedM>
 SparseSolverReturnCode solve_sparse_linear_system(
         DerivedV1& residual,
         DerivedM& jacobian,
         DerivedV2& update,
         SparseSolver solver)
 {
     if (not jacobian.isCompressed()) jacobian.makeCompressed();
     if (solver == SparseSolver::SparseQR) {
         return solve_linear_system_sparseqr(residual, jacobian, update);
     } else if (solver == SparseSolver::SparseLU) {
         return solve_linear_system_sparselu(residual, jacobian, update);
-    }
-    else {
+#ifdef EIGEN_UNSUPPORTED_FOUND
+    } else if (solver == SparseSolver::GMRES) {
+        return solve_linear_system_gmres(residual, jacobian, update);
+#endif
+    } else {
         return solve_linear_system_bicgstab(residual, jacobian, update);
     }
 }
 
 template <class DerivedV1, class DerivedV2, class DerivedM>
 SparseSolverReturnCode solve_linear_system_sparseqr(DerivedV1& residual, DerivedM& jacobian, DerivedV2& update)
 {
     Eigen::SparseQR<DerivedM, Eigen::COLAMDOrdering<int>> solver(jacobian);
     if (solver.info() != Eigen::Success)
     {
         return SparseSolverReturnCode::FailedDecomposition;
     }
     update = solver.solve(-residual);
     if (solver.info() != Eigen::Success)
     {
         return SparseSolverReturnCode::FailedSystemSolving;
     }
     return SparseSolverReturnCode::Success;
 }
 
 template <class DerivedV1, class DerivedV2, class DerivedM>
 SparseSolverReturnCode solve_linear_system_sparselu(DerivedV1& residual, DerivedM& jacobian, DerivedV2& update)
 {
     Eigen::SparseLU<DerivedM> solver(jacobian);
     if (solver.info() != Eigen::Success)
     {
         return SparseSolverReturnCode::FailedDecomposition;;
     }
     update = solver.solve(-residual);
     if (solver.info() != Eigen::Success)
     {
         return SparseSolverReturnCode::FailedSystemSolving;
     }
     return SparseSolverReturnCode::Success;
 }
 
 template <class DerivedV1, class DerivedV2, class DerivedM>
 SparseSolverReturnCode solve_linear_system_bicgstab(DerivedV1& residual, DerivedM& jacobian, DerivedV2& update)
 {
     Eigen::BiCGSTAB<DerivedM, Eigen::IncompleteLUT<typename DerivedM::Scalar>> solver(jacobian);
     update = solver.solve(-residual);
     if (solver.info() != Eigen::Success)
     {
         return SparseSolverReturnCode::FailedSystemSolving;
     }
     return SparseSolverReturnCode::Success;
 }
 
+
+template <class DerivedV1, class DerivedV2, class DerivedM>
+SparseSolverReturnCode solve_linear_system_gmres(DerivedV1& residual, DerivedM& jacobian, DerivedV2& update)
+{
+    Eigen::GMRES<DerivedM, Eigen::IncompleteLUT<typename DerivedM::Scalar>> solver(jacobian);
+    update = solver.solve(-residual);
+    if (solver.info() != Eigen::Success)
+    {
+        return SparseSolverReturnCode::FailedSystemSolving;
+    }
+    return SparseSolverReturnCode::Success;
+}
+
 } // end namespace specmicp
 
 #endif //SPECMICP_UTILS_SPARSESOLVER_HPP
diff --git a/src/utils/sparse_solver_structs.hpp b/src/utils/sparse_solver_structs.hpp
index b410016..eed59d5 100644
--- a/src/utils/sparse_solver_structs.hpp
+++ b/src/utils/sparse_solver_structs.hpp
@@ -1,24 +1,28 @@
 #ifndef SPECMICP_UTILS_SPARSESOLVERSTRUCT_HPP
 #define SPECMICP_UTILS_SPARSESOLVERSTRUCT_HPP
 
 
 namespace specmicp {
 
 //! \brief Available sparse solver
 enum class SparseSolver
 {
     SparseLU, //!< Eigen Sparse LU solver
     SparseQR, //!< Eigen Sparse QR solver
-    BiCGSTAB  //!< Eigne BiCGSTAB solver
+    BiCGSTAB  //!< Eigen BiCGSTAB solver
+#ifdef EIGEN_UNSUPPORTED_FOUND
+    ,
+    GMRES     //!< Eigen unsupported GMRES solver
+#endif
 };
 
 enum class SparseSolverReturnCode
 {
     FailedDecomposition =-2, //!< Decomposition has failed
     FailedSystemSolving =-1, //!< Solving linear system has failed
     Success = 0              //!< Success
 };
 
 } // end namespace specmicp
 
 #endif //SPECMICP_DFPMSOLVER_SPARSESOLVERSTRUCT_HPP