Browse Source

Adapted to new solver interface some tests and bugfixes. Tests still failing.

Former-commit-id: da3b75aefd
main
David_Korzeniewski 11 years ago
parent
commit
716cf3abdd
  1. 4
      src/modelchecker/AbstractModelChecker.cpp
  2. 20
      src/modelchecker/prctl/SparseDtmcPrctlModelChecker.cpp
  3. 2
      src/modelchecker/prctl/SparseDtmcPrctlModelChecker.h
  4. 29
      src/modelchecker/prctl/SparseMdpPrctlModelChecker.cpp
  5. 14
      test/functional/modelchecker/SparseMdpPrctlModelCheckerTest.cpp

4
src/modelchecker/AbstractModelChecker.cpp

@ -217,7 +217,7 @@ namespace storm {
} }
std::unique_ptr<CheckResult> AbstractModelChecker::checkExpectedTimeOperatorFormula(storm::logic::ExpectedTimeOperatorFormula const& stateFormula) { std::unique_ptr<CheckResult> AbstractModelChecker::checkExpectedTimeOperatorFormula(storm::logic::ExpectedTimeOperatorFormula const& stateFormula) {
STORM_LOG_THROW(stateFormula.getSubformula().isStateFormula(), storm::exceptions::InvalidArgumentException, "The given formula is invalid.");
STORM_LOG_THROW(stateFormula.getSubformula().isEventuallyFormula(), storm::exceptions::InvalidArgumentException, "The given formula is invalid.");
// If the reward bound is 0, is suffices to do qualitative model checking. // If the reward bound is 0, is suffices to do qualitative model checking.
bool qualitative = false; bool qualitative = false;
@ -249,7 +249,7 @@ namespace storm {
} }
std::unique_ptr<CheckResult> AbstractModelChecker::checkLongRunAverageOperatorFormula(storm::logic::LongRunAverageOperatorFormula const& stateFormula) { std::unique_ptr<CheckResult> AbstractModelChecker::checkLongRunAverageOperatorFormula(storm::logic::LongRunAverageOperatorFormula const& stateFormula) {
STORM_LOG_THROW(stateFormula.getSubformula().isEventuallyFormula(), storm::exceptions::InvalidArgumentException, "The given formula is invalid.");
STORM_LOG_THROW(stateFormula.getSubformula().isStateFormula(), storm::exceptions::InvalidArgumentException, "The given formula is invalid.");
std::unique_ptr<CheckResult> result; std::unique_ptr<CheckResult> result;
if (stateFormula.hasOptimalityType()) { if (stateFormula.hasOptimalityType()) {

20
src/modelchecker/prctl/SparseDtmcPrctlModelChecker.cpp

@ -340,7 +340,6 @@ namespace storm {
storm::storage::BitVector statesNotInBsccs = ~statesInBsccs; storm::storage::BitVector statesNotInBsccs = ~statesInBsccs;
// calculate steady state distribution for all BSCCs by calculating an eigenvector for the eigenvalue 1 of the transposed transition matrix for the bsccs // calculate steady state distribution for all BSCCs by calculating an eigenvector for the eigenvalue 1 of the transposed transition matrix for the bsccs
std::unique_ptr<storm::solver::LinearEquationSolver<ValueType>> solver = storm::utility::solver::getLinearEquationSolver<ValueType>();
storm::storage::SparseMatrix<ValueType> bsccEquationSystem = transitionMatrix.getSubmatrix(false, statesInBsccs, statesInBsccs, true).transpose(); storm::storage::SparseMatrix<ValueType> bsccEquationSystem = transitionMatrix.getSubmatrix(false, statesInBsccs, statesInBsccs, true).transpose();
ValueType one = storm::utility::one<ValueType>(); ValueType one = storm::utility::one<ValueType>();
@ -356,7 +355,10 @@ namespace storm {
std::vector<ValueType> bsccEquationSystemRightSide(bsccEquationSystem.getColumnCount(), zero); std::vector<ValueType> bsccEquationSystemRightSide(bsccEquationSystem.getColumnCount(), zero);
std::vector<ValueType> bsccEquationSystemSolution(bsccEquationSystem.getColumnCount(), one); std::vector<ValueType> bsccEquationSystemSolution(bsccEquationSystem.getColumnCount(), one);
solver->solveEquationSystem(bsccEquationSystem, bsccEquationSystemSolution, bsccEquationSystemRightSide);
{
auto solver = this->linearEquationSolverFactory->create(bsccEquationSystem);
solver->solveEquationSystem(bsccEquationSystemSolution, bsccEquationSystemRightSide);
}
//calculate LRA Value for each BSCC from steady state distribution in BSCCs //calculate LRA Value for each BSCC from steady state distribution in BSCCs
// we have to do some scaling, as the probabilities for each BSCC have to sum up to one, which they don't necessarily do in the solution of the equation system // we have to do some scaling, as the probabilities for each BSCC have to sum up to one, which they don't necessarily do in the solution of the equation system
@ -395,7 +397,10 @@ namespace storm {
std::vector<ValueType> rewardSolution(rewardEquationSystemMatrix.getColumnCount(), one); std::vector<ValueType> rewardSolution(rewardEquationSystemMatrix.getColumnCount(), one);
solver->solveEquationSystem(rewardEquationSystemMatrix, rewardSolution, rewardRightSide);
{
auto solver = this->linearEquationSolverFactory->create(rewardEquationSystemMatrix);
solver->solveEquationSystem(rewardSolution, rewardRightSide);
}
// now fill the result vector // now fill the result vector
std::vector<ValueType> result(numOfStates); std::vector<ValueType> result(numOfStates);
@ -453,7 +458,7 @@ namespace storm {
template<typename ValueType> template<typename ValueType>
ValueType SparseDtmcPrctlModelChecker<ValueType>::computeLraForBSCC(storm::storage::SparseMatrix<ValueType> const& transitionMatrix, storm::storage::BitVector const& psiStates, storm::storage::StronglyConnectedComponent const& bscc) {
ValueType SparseDtmcPrctlModelChecker<ValueType>::computeLraForBSCC(storm::storage::SparseMatrix<ValueType> const& transitionMatrix, storm::storage::BitVector const& psiStates, storm::storage::StronglyConnectedComponent const& bscc, storm::utility::solver::LinearEquationSolverFactory<ValueType> const& linearEquationSolverFactory) {
//if size is one we can immediately derive the result //if size is one we can immediately derive the result
if (bscc.size() == 1){ if (bscc.size() == 1){
if (psiStates.get(*(bscc.begin()))) { if (psiStates.get(*(bscc.begin()))) {
@ -462,7 +467,6 @@ namespace storm {
return storm::utility::zero<ValueType>(); return storm::utility::zero<ValueType>();
} }
} }
std::unique_ptr<storm::solver::LinearEquationSolver<ValueType>> solver = storm::utility::solver::getLinearEquationSolver<ValueType>();
storm::storage::BitVector subsystem = storm::storage::BitVector(transitionMatrix.getRowCount()); storm::storage::BitVector subsystem = storm::storage::BitVector(transitionMatrix.getRowCount());
subsystem.set(bscc.begin(), bscc.end()); subsystem.set(bscc.begin(), bscc.end());
@ -502,7 +506,11 @@ namespace storm {
std::vector<ValueType> b(subsystemMatrix.getRowCount(), zero); std::vector<ValueType> b(subsystemMatrix.getRowCount(), zero);
b[subsystemMatrix.getRowCount() - 1] = one; b[subsystemMatrix.getRowCount() - 1] = one;
solver->solveEquationSystem(subsystemMatrix, steadyStateDist, b);
{
auto solver = linearEquationSolverFactory.create(subsystemMatrix);
solver->solveEquationSystem(steadyStateDist, b);
}
//remove the last entry of the vector as it was just there to enforce the unique solution //remove the last entry of the vector as it was just there to enforce the unique solution
steadyStateDist.pop_back(); steadyStateDist.pop_back();

2
src/modelchecker/prctl/SparseDtmcPrctlModelChecker.h

@ -43,7 +43,7 @@ namespace storm {
static std::vector<ValueType> computeReachabilityRewardsHelper(storm::storage::SparseMatrix<ValueType> const& transitionMatrix, boost::optional<std::vector<ValueType>> const& stateRewardVector, boost::optional<storm::storage::SparseMatrix<ValueType>> const& transitionRewardMatrix, storm::storage::SparseMatrix<ValueType> const& backwardTransitions, storm::storage::BitVector const& targetStates, storm::utility::solver::LinearEquationSolverFactory<ValueType> const& linearEquationSolverFactory, bool qualitative); static std::vector<ValueType> computeReachabilityRewardsHelper(storm::storage::SparseMatrix<ValueType> const& transitionMatrix, boost::optional<std::vector<ValueType>> const& stateRewardVector, boost::optional<storm::storage::SparseMatrix<ValueType>> const& transitionRewardMatrix, storm::storage::SparseMatrix<ValueType> const& backwardTransitions, storm::storage::BitVector const& targetStates, storm::utility::solver::LinearEquationSolverFactory<ValueType> const& linearEquationSolverFactory, bool qualitative);
std::vector<ValueType> computeLongRunAverageHelper(storm::storage::BitVector const& psiStates, bool qualitative) const; std::vector<ValueType> computeLongRunAverageHelper(storm::storage::BitVector const& psiStates, bool qualitative) const;
static ValueType computeLraForBSCC(storm::storage::SparseMatrix<ValueType> const& transitionMatrix, storm::storage::BitVector const& goalStates, storm::storage::StronglyConnectedComponent const& bscc);
static ValueType computeLraForBSCC(storm::storage::SparseMatrix<ValueType> const& transitionMatrix, storm::storage::BitVector const& goalStates, storm::storage::StronglyConnectedComponent const& bscc, storm::utility::solver::LinearEquationSolverFactory<ValueType> const& linearEquationSolverFactory);
// An object that is used for retrieving linear equation solvers. // An object that is used for retrieving linear equation solvers.
std::unique_ptr<storm::utility::solver::LinearEquationSolverFactory<ValueType>> linearEquationSolverFactory; std::unique_ptr<storm::utility::solver::LinearEquationSolverFactory<ValueType>> linearEquationSolverFactory;

29
src/modelchecker/prctl/SparseMdpPrctlModelChecker.cpp

@ -366,14 +366,12 @@ namespace storm {
//This transitions have the LRA of the MEC as reward. //This transitions have the LRA of the MEC as reward.
//The expected reward corresponds to sum of LRAs in MEC weighted by the reachability probability of the MEC //The expected reward corresponds to sum of LRAs in MEC weighted by the reachability probability of the MEC
std::unique_ptr<storm::solver::LinearEquationSolver<ValueType>> solver = storm::utility::solver::getLinearEquationSolver<ValueType>();
//we now build the submatrix of the transition matrix of the system with the auxiliary state, that only contains the states from //we now build the submatrix of the transition matrix of the system with the auxiliary state, that only contains the states from
//the original state, i.e. all "maybe-states" //the original state, i.e. all "maybe-states"
storm::storage::SparseMatrixBuilder<ValueType> rewardEquationSystemMatrixBuilder(transitionMatrix.getRowCount() + statesInMecs.getNumberOfSetBits(), storm::storage::SparseMatrixBuilder<ValueType> rewardEquationSystemMatrixBuilder(transitionMatrix.getRowCount() + statesInMecs.getNumberOfSetBits(),
transitionMatrix.getColumnCount(), transitionMatrix.getColumnCount(),
transitionMatrix.getEntryCount(), transitionMatrix.getEntryCount(),
true,
false,
true, true,
transitionMatrix.getRowGroupCount()); transitionMatrix.getRowGroupCount());
@ -384,19 +382,32 @@ namespace storm {
for (uint_fast64_t rowGroupIndex = 0; rowGroupIndex < transitionMatrix.getRowGroupCount(); ++rowGroupIndex) { for (uint_fast64_t rowGroupIndex = 0; rowGroupIndex < transitionMatrix.getRowGroupCount(); ++rowGroupIndex) {
rewardEquationSystemMatrixBuilder.newRowGroup(rowIndex); rewardEquationSystemMatrixBuilder.newRowGroup(rowIndex);
for (uint_fast64_t i = 0; i < transitionMatrix.getRowGroupSize(rowGroupIndex); ++i) { for (uint_fast64_t i = 0; i < transitionMatrix.getRowGroupSize(rowGroupIndex); ++i) {
//we have to make sure that an entry exists for all diagonal elements, even if it is zero. Other wise the call to convertToEquationSystem will produce wrong results or fail.
bool foundDiagonal = false;
for (auto entry : transitionMatrix.getRow(oldRowIndex)) { for (auto entry : transitionMatrix.getRow(oldRowIndex)) {
if (!foundDiagonal) {
if (entry.getColumn() > rowGroupIndex) {
foundDiagonal = true;
rewardEquationSystemMatrixBuilder.addNextValue(rowIndex, rowGroupIndex, zero);
} else if (entry.getColumn() == rowGroupIndex) {
foundDiagonal = true;
}
}
//copy over values from transition matrix of the actual system //copy over values from transition matrix of the actual system
rewardEquationSystemMatrixBuilder.addNextValue(rowIndex, entry.getColumn(), entry.getValue()); rewardEquationSystemMatrixBuilder.addNextValue(rowIndex, entry.getColumn(), entry.getValue());
} }
if (!foundDiagonal) {
rewardEquationSystemMatrixBuilder.addNextValue(rowIndex, rowGroupIndex, zero);
}
++oldRowIndex; ++oldRowIndex;
++rowIndex; ++rowIndex;
} }
++rowGroupIndex;
if (statesInMecs.get(rowGroupIndex)) { if (statesInMecs.get(rowGroupIndex)) {
//put the transition-reward on the right side
rewardRightSide[rowIndex] = mecLra[stateToMecIndexMap[rowGroupIndex]];
//add the choice where we go to the auxiliary state, which is a row with all zeros in the submatrix we build //add the choice where we go to the auxiliary state, which is a row with all zeros in the submatrix we build
rewardEquationSystemMatrixBuilder.addNextValue(rowIndex, rowGroupIndex, zero);
++rowIndex; ++rowIndex;
//put the transition-reward on the right side
rewardRightSide[rowIndex] = mecLra[rowGroupIndex];
} }
} }
@ -405,7 +416,11 @@ namespace storm {
std::vector<ValueType> result(rewardEquationSystemMatrix.getColumnCount(), one); std::vector<ValueType> result(rewardEquationSystemMatrix.getColumnCount(), one);
solver->solveEquationSystem(rewardEquationSystemMatrix, result, rewardRightSide);
{
auto solver = this->MinMaxLinearEquationSolverFactory->create(rewardEquationSystemMatrix);
solver->solveEquationSystem(minimize, result, rewardRightSide);
}
return result; return result;
} }

14
test/functional/modelchecker/SparseMdpPrctlModelCheckerTest.cpp

@ -197,7 +197,7 @@ TEST(SparseMdpPrctlModelCheckerTest, AsynchronousLeader) {
TEST(SparseMdpPrctlModelCheckerTest, LRA) { TEST(SparseMdpPrctlModelCheckerTest, LRA) {
storm::storage::SparseMatrixBuilder<double> matrixBuilder; storm::storage::SparseMatrixBuilder<double> matrixBuilder;
std::shared_ptr<storm::models::Mdp<double>> mdp;
std::shared_ptr<storm::models::sparse::Mdp<double>> mdp;
{ {
matrixBuilder = storm::storage::SparseMatrixBuilder<double>(2, 2, 2); matrixBuilder = storm::storage::SparseMatrixBuilder<double>(2, 2, 2);
@ -205,16 +205,16 @@ TEST(SparseMdpPrctlModelCheckerTest, LRA) {
matrixBuilder.addNextValue(1, 0, 1.); matrixBuilder.addNextValue(1, 0, 1.);
storm::storage::SparseMatrix<double> transitionMatrix = matrixBuilder.build(); storm::storage::SparseMatrix<double> transitionMatrix = matrixBuilder.build();
storm::models::AtomicPropositionsLabeling ap(2, 1);
ap.addAtomicProposition("a");
ap.addAtomicPropositionToState("a", 1);
storm::models::sparse::StateLabeling ap(2);
ap.addLabel("a");
ap.addLabelToState("a", 1);
mdp.reset(new storm::models::Mdp<double>(transitionMatrix, ap, boost::none, boost::none, boost::none));
mdp.reset(new storm::models::sparse::Mdp<double>(transitionMatrix, ap, boost::none, boost::none, boost::none));
storm::modelchecker::SparseMdpPrctlModelChecker<double> checker(*mdp, std::shared_ptr<storm::solver::NativeNondeterministicLinearEquationSolver<double>>(new storm::solver::NativeNondeterministicLinearEquationSolver<double>()));
storm::modelchecker::SparseMdpPrctlModelChecker<double> checker(*mdp, std::unique_ptr<storm::utility::solver::MinMaxLinearEquationSolverFactory<double>>(new storm::utility::solver::NativeMinMaxLinearEquationSolverFactory<double>()));
auto labelFormula = std::make_shared<storm::logic::AtomicLabelFormula>("a"); auto labelFormula = std::make_shared<storm::logic::AtomicLabelFormula>("a");
auto lraFormula = std::make_shared<storm::logic::LongRunAverageOperatorFormula>(storm::logic::OptimalityType::Minimize, labelFormula);
auto lraFormula = std::make_shared<storm::logic::LongRunAverageOperatorFormula>(storm::logic::OptimalityType::Maximize, labelFormula);
std::unique_ptr<storm::modelchecker::CheckResult> result = checker.check(*lraFormula); std::unique_ptr<storm::modelchecker::CheckResult> result = checker.check(*lraFormula);
storm::modelchecker::ExplicitQuantitativeCheckResult<double>& quantitativeResult = result->asExplicitQuantitativeCheckResult<double>(); storm::modelchecker::ExplicitQuantitativeCheckResult<double>& quantitativeResult = result->asExplicitQuantitativeCheckResult<double>();

Loading…
Cancel
Save