From af980ed93cb379c6bd7270e75d95140eb798c9bb Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Atgeirr=20Fl=C3=B8=20Rasmussen?= Date: Mon, 7 Dec 2015 16:03:46 +0100 Subject: [PATCH 1/8] Creates GridInit template class. --- CMakeLists_files.cmake | 1 + opm/autodiff/GridInit.hpp | 94 +++++++++++++++++++++++++++++++++++++++ 2 files changed, 95 insertions(+) create mode 100644 opm/autodiff/GridInit.hpp diff --git a/CMakeLists_files.cmake b/CMakeLists_files.cmake index 989e56110..9a6d831c2 100644 --- a/CMakeLists_files.cmake +++ b/CMakeLists_files.cmake @@ -143,6 +143,7 @@ list (APPEND PUBLIC_HEADER_FILES opm/autodiff/ExtractParallelGridInformationToISTL.hpp opm/autodiff/GeoProps.hpp opm/autodiff/GridHelpers.hpp + opm/autodiff/GridInit.hpp opm/autodiff/ImpesTPFAAD.hpp opm/autodiff/moduleVersion.hpp opm/autodiff/NewtonIterationBlackoilCPR.hpp diff --git a/opm/autodiff/GridInit.hpp b/opm/autodiff/GridInit.hpp new file mode 100644 index 000000000..76b701b95 --- /dev/null +++ b/opm/autodiff/GridInit.hpp @@ -0,0 +1,94 @@ +/* + Copyright 2015 SINTEF ICT, Applied Mathematics. + + This file is part of the Open Porous Media project (OPM). + + OPM is free software: you can redistribute it and/or modify + it under the terms of the GNU General Public License as published by + the Free Software Foundation, either version 3 of the License, or + (at your option) any later version. + + OPM is distributed in the hope that it will be useful, + but WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the + GNU General Public License for more details. + + You should have received a copy of the GNU General Public License + along with OPM. If not, see . +*/ + +#ifndef OPM_GRIDINIT_HEADER_INCLUDED +#define OPM_GRIDINIT_HEADER_INCLUDED + +#include +#include +#include + +#if HAVE_DUNE_CORNERPOINT +#include +#endif + + +namespace Opm +{ + + /// A class intended to give a generic interface to + /// initializing and accessing UnstructuredGrid and CpGrid, + /// using specialized templates to accomplish this. + template + class GridInit + { + public: + /// Initialize from a deck and/or an eclipse state and (logical cartesian) specified pore volumes. + GridInit(DeckConstPtr, EclipseStateConstPtr, const std::vector&) + { + OPM_THROW(std::logic_error, "Found no specialization for GridInit for the requested Grid class."); + } + }; + + + /// Specialization for UnstructuredGrid. + template <> + class GridInit + { + public: + /// Initialize from a deck and/or an eclipse state and (logical cartesian) specified pore volumes. + GridInit(DeckConstPtr, EclipseStateConstPtr eclipse_state, const std::vector& porv) + : grid_manager_(eclipse_state->getEclipseGrid(), porv) + { + } + /// Access the created grid. + const UnstructuredGrid& grid() + { + return *grid_manager_.c_grid(); + } + private: + GridManager grid_manager_; + }; + + +#if HAVE_DUNE_CORNERPOINT + /// Specialization for CpGrid. + template <> + class GridInit + { + public: + /// Initialize from a deck and/or an eclipse state and (logical cartesian) specified pore volumes. + GridInit(DeckConstPtr deck, EclipseStateConstPtr, const std::vector& porv) + { + grid_.processEclipseFormat(deck, false, false, false, porv); + } + /// Access the created grid. Note that mutable access may be required for load balancing. + Dune::CpGrid& grid() + { + return grid_; + } + private: + Dune::CpGrid grid_; + }; +#endif // HAVE_DUNE_CORNERPOINT + + +} // namespace Opm + +#endif // OPM_GRIDINIT_HEADER_INCLUDED From 7c5256031c76f2863f0ed5e47ce9d7fdbb18591f Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Atgeirr=20Fl=C3=B8=20Rasmussen?= Date: Mon, 7 Dec 2015 16:04:09 +0100 Subject: [PATCH 2/8] Use GridInit in flow.cpp. --- examples/flow.cpp | 23 +++++++---------------- 1 file changed, 7 insertions(+), 16 deletions(-) diff --git a/examples/flow.cpp b/examples/flow.cpp index f428b4f35..4aedc7d8f 100644 --- a/examples/flow.cpp +++ b/examples/flow.cpp @@ -35,23 +35,19 @@ #include #endif +#include + #if HAVE_DUNE_CORNERPOINT && WANT_DUNE_CORNERPOINTGRID #define USE_DUNE_CORNERPOINTGRID 1 #include -#include #else #undef USE_DUNE_CORNERPOINTGRID #endif -#include - -#include - -#include -#include #include #include #include +#include #include #include @@ -253,17 +249,12 @@ try std::vector porv = eclipseState->getDoubleGridProperty("PORV")->getData(); #if USE_DUNE_CORNERPOINTGRID - // Dune::CpGrid as grid manager - typedef Dune::CpGrid Grid; - // Grid init - Grid grid; - grid.processEclipseFormat(deck, false, false, false, porv); + typedef Dune::CpGrid Grid; #else - // UnstructuredGrid as grid manager - typedef UnstructuredGrid Grid; - GridManager gridManager( eclipseState->getEclipseGrid(), porv ); - const Grid& grid = *(gridManager.c_grid()); + typedef UnstructuredGrid Grid; #endif + GridInit grid_init(deck, eclipseState, porv); + auto&& grid = grid_init.grid(); // Possibly override IOConfig setting (from deck) for how often RESTART files should get written to disk (every N report step) if (param.has("output_interval")) { From be9b6a3cd241d3d24c52963ae566ba8a831ec726 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Atgeirr=20Fl=C3=B8=20Rasmussen?= Date: Tue, 8 Dec 2015 09:57:43 +0100 Subject: [PATCH 3/8] Unconditionally instantiate the (possibly fake) MPI helper. This reduces the difference between flow and flow_mpi. For builds without MPI, the fake helper from Dune is instantiated, which has the same interface. --- examples/flow.cpp | 9 +++------ 1 file changed, 3 insertions(+), 6 deletions(-) diff --git a/examples/flow.cpp b/examples/flow.cpp index 4aedc7d8f..7f1e05913 100644 --- a/examples/flow.cpp +++ b/examples/flow.cpp @@ -124,16 +124,13 @@ main(int argc, char** argv) try { using namespace Opm; -#if USE_DUNE_CORNERPOINTGRID + // Must ensure an instance of the helper is created to initialise MPI. + // For a build without MPI the Dune::FakeMPIHelper is used, so rank will + // be 0 and size 1. const Dune::MPIHelper& mpi_helper = Dune::MPIHelper::instance(argc, argv); const int mpi_rank = mpi_helper.rank(); const int mpi_size = mpi_helper.size(); -#else - // default values for serial run - const int mpi_rank = 0; - const int mpi_size = 1; -#endif // Write parameters used for later reference. (only if rank is zero) const bool output_cout = ( mpi_rank == 0 ); From 51a03e6212bb41f87a8aa9500e52ae91b9fc7105 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Atgeirr=20Fl=C3=B8=20Rasmussen?= Date: Tue, 8 Dec 2015 10:36:44 +0100 Subject: [PATCH 4/8] Extract content of flow main() to separate template function. The function is templated on grid and simulator class, so this allows flow and flow_mpi to be implemented without any macro tricks, instead simply including and using different grid types. --- opm/autodiff/flowMain.hpp | 445 ++++++++++++++++++++++++++++++++++++++ 1 file changed, 445 insertions(+) create mode 100644 opm/autodiff/flowMain.hpp diff --git a/opm/autodiff/flowMain.hpp b/opm/autodiff/flowMain.hpp new file mode 100644 index 000000000..3ae9855c8 --- /dev/null +++ b/opm/autodiff/flowMain.hpp @@ -0,0 +1,445 @@ +/* + Copyright 2013, 2014, 2015 SINTEF ICT, Applied Mathematics. + Copyright 2014 Dr. Blatt - HPC-Simulation-Software & Services + Copyright 2015 IRIS AS + Copyright 2014 STATOIL ASA. + + This file is part of the Open Porous Media project (OPM). + + OPM is free software: you can redistribute it and/or modify + it under the terms of the GNU General Public License as published by + the Free Software Foundation, either version 3 of the License, or + (at your option) any later version. + + OPM is distributed in the hope that it will be useful, + but WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the + GNU General Public License for more details. + + You should have received a copy of the GNU General Public License + along with OPM. If not, see . +*/ + +#ifndef OPM_FLOWMAIN_HEADER_INCLUDED +#define OPM_FLOWMAIN_HEADER_INCLUDED + + +#include + +#include +#if DUNE_VERSION_NEWER(DUNE_COMMON, 2, 3) +#include +#else +#include +#endif + +#include + + +#include +#include +#include +#include + +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include // Note: the GridHelpers must be included before this (to make overloads available). \TODO: Fix. + +#include +#include +#include +#include + +#include +#include +#include +#include + +#include +#include + +#include +#include +#include + +#include + +#include +#include +#include +#include +#include +#include +#include +#include + +#include +#include + +#ifdef _OPENMP +#include +#endif + +#include +#include +#include +#include +#include +#include +#include + + + + +namespace Opm +{ + + /// Calling this will print the unused parameters, if any. + /// This allows a user to catch typos and misunderstandings in the + /// use of simulator parameters. + inline void warnIfUnusedParams(const Opm::parameter::ParameterGroup& param) + { + if (param.anyUnused()) { + std::cout << "-------------------- Unused parameters: --------------------\n"; + param.displayUsage(); + std::cout << "----------------------------------------------------------------" << std::endl; + } + } + + + template + inline int flowMain(int argc, char** argv) + try { + using namespace Opm; + + // Must ensure an instance of the helper is created to initialise MPI. + // For a build without MPI the Dune::FakeMPIHelper is used, so rank will + // be 0 and size 1. + const Dune::MPIHelper& mpi_helper = Dune::MPIHelper::instance(argc, argv); + const int mpi_rank = mpi_helper.rank(); + const int mpi_size = mpi_helper.size(); + + // Write parameters used for later reference. (only if rank is zero) + const bool output_cout = ( mpi_rank == 0 ); + + if (output_cout) + { + std::string version = moduleVersionName(); + std::cout << "**********************************************************************\n"; + std::cout << "* *\n"; + std::cout << "* This is Flow (version " << version << ")" + << std::string(26 - version.size(), ' ') << "*\n"; + std::cout << "* *\n"; + std::cout << "* Flow is a simulator for fully implicit three-phase black-oil flow, *\n"; + std::cout << "* and is part of OPM. For more information see: *\n"; + std::cout << "* http://opm-project.org *\n"; + std::cout << "* *\n"; + std::cout << "**********************************************************************\n\n"; + } + +#ifdef _OPENMP + if (!getenv("OMP_NUM_THREADS")) { + //Default to at most 4 threads, regardless of + //number of cores (unless ENV(OMP_NUM_THREADS) is defined) + int num_cores = omp_get_num_procs(); + int num_threads = std::min(4, num_cores); + omp_set_num_threads(num_threads); + } +#pragma omp parallel + if (omp_get_thread_num() == 0){ + //opm_get_num_threads() only works as expected within a parallel region. + std::cout << "OpenMP using " << omp_get_num_threads() << " threads." << std::endl; + } +#endif + + // Read parameters, see if a deck was specified on the command line. + if ( output_cout ) + { + std::cout << "--------------- Reading parameters ---------------" << std::endl; + } + + parameter::ParameterGroup param(argc, argv, false, output_cout); + if( !output_cout ) + { + param.disableOutput(); + } + + if (!param.unhandledArguments().empty()) { + if (param.unhandledArguments().size() != 1) { + std::cerr << "You can only specify a single input deck on the command line.\n"; + return EXIT_FAILURE; + } else { + param.insertParameter("deck_filename", param.unhandledArguments()[0]); + } + } + + // We must have an input deck. Grid and props will be read from that. + if (!param.has("deck_filename")) { + std::cerr << "This program must be run with an input deck.\n" + "Specify the deck filename either\n" + " a) as a command line argument by itself\n" + " b) as a command line parameter with the syntax deck_filename=, or\n" + " c) as a parameter in a parameter file (.param or .xml) passed to the program.\n"; + return EXIT_FAILURE; + } + + // bool check_well_controls = false; + // int max_well_control_iterations = 0; + double gravity[3] = { 0.0 }; + std::string deck_filename = param.get("deck_filename"); + + // Write parameters used for later reference. (only if rank is zero) + bool output = ( mpi_rank == 0 ) && param.getDefault("output", true); + std::string output_dir; + if (output) { + // Create output directory if needed. + output_dir = + param.getDefault("output_dir", std::string("output")); + boost::filesystem::path fpath(output_dir); + try { + create_directories(fpath); + } + catch (...) { + std::cerr << "Creating directories failed: " << fpath << std::endl; + return EXIT_FAILURE; + } + // Write simulation parameters. + param.writeParam(output_dir + "/simulation.param"); + } + + std::string logFile = output_dir + "/LOGFILE.txt"; + Opm::ParserPtr parser(new Opm::Parser()); + { + std::shared_ptr streamLog = std::make_shared(logFile , Opm::Log::DefaultMessageTypes); + std::shared_ptr counterLog = std::make_shared(Opm::Log::DefaultMessageTypes); + + Opm::OpmLog::addBackend( "STREAM" , streamLog ); + Opm::OpmLog::addBackend( "COUNTER" , counterLog ); + } + + Opm::ParseMode parseMode({{ ParseMode::PARSE_RANDOM_SLASH , InputError::IGNORE }}); + Opm::DeckConstPtr deck; + std::shared_ptr eclipseState; + try { + deck = parser->parseFile(deck_filename, parseMode); + Opm::checkDeck(deck); + eclipseState.reset(new Opm::EclipseState(deck , parseMode)); + } + catch (const std::invalid_argument& e) { + std::cerr << "Failed to create valid ECLIPSESTATE object. See logfile: " << logFile << std::endl; + std::cerr << "Exception caught: " << e.what() << std::endl; + return EXIT_FAILURE; + } + + std::vector porv = eclipseState->getDoubleGridProperty("PORV")->getData(); + GridInit grid_init(deck, eclipseState, porv); + auto&& grid = grid_init.grid(); + + // Possibly override IOConfig setting (from deck) for how often RESTART files should get written to disk (every N report step) + if (param.has("output_interval")) { + int output_interval = param.get("output_interval"); + IOConfigPtr ioConfig = eclipseState->getIOConfig(); + ioConfig->overrideRestartWriteInterval((size_t)output_interval); + } + + const PhaseUsage pu = Opm::phaseUsageFromDeck(deck); + + std::vector compressedToCartesianIdx; + Opm::createGlobalCellArray(grid, compressedToCartesianIdx); + + typedef BlackoilPropsAdFromDeck::MaterialLawManager MaterialLawManager; + auto materialLawManager = std::make_shared(); + materialLawManager->initFromDeck(deck, eclipseState, compressedToCartesianIdx); + + // Rock and fluid init + BlackoilPropertiesFromDeck props( deck, eclipseState, materialLawManager, + Opm::UgGridHelpers::numCells(grid), + Opm::UgGridHelpers::globalCell(grid), + Opm::UgGridHelpers::cartDims(grid), + param); + + BlackoilPropsAdFromDeck new_props( deck, eclipseState, materialLawManager, grid ); + // check_well_controls = param.getDefault("check_well_controls", false); + // max_well_control_iterations = param.getDefault("max_well_control_iterations", 10); + // Rock compressibility. + + RockCompressibility rock_comp(deck, eclipseState); + + // Gravity. + gravity[2] = deck->hasKeyword("NOGRAV") ? 0.0 : unit::gravity; + + BlackoilState state; + // Init state variables (saturation and pressure). + if (param.has("init_saturation")) { + initStateBasic(Opm::UgGridHelpers::numCells(grid), + Opm::UgGridHelpers::globalCell(grid), + Opm::UgGridHelpers::cartDims(grid), + Opm::UgGridHelpers::numFaces(grid), + Opm::UgGridHelpers::faceCells(grid), + Opm::UgGridHelpers::beginFaceCentroids(grid), + Opm::UgGridHelpers::beginCellCentroids(grid), + Opm::UgGridHelpers::dimensions(grid), + props, param, gravity[2], state); + + initBlackoilSurfvol(Opm::UgGridHelpers::numCells(grid), props, state); + + enum { Oil = BlackoilPhases::Liquid, Gas = BlackoilPhases::Vapour }; + if (pu.phase_used[Oil] && pu.phase_used[Gas]) { + const int numPhases = props.numPhases(); + const int numCells = Opm::UgGridHelpers::numCells(grid); + for (int c = 0; c < numCells; ++c) { + state.gasoilratio()[c] = state.surfacevol()[c*numPhases + pu.phase_pos[Gas]] + / state.surfacevol()[c*numPhases + pu.phase_pos[Oil]]; + } + } + } else if (deck->hasKeyword("EQUIL") && props.numPhases() == 3) { + state.init(Opm::UgGridHelpers::numCells(grid), + Opm::UgGridHelpers::numFaces(grid), + props.numPhases()); + const double grav = param.getDefault("gravity", unit::gravity); + initStateEquil(grid, props, deck, eclipseState, grav, state); + state.faceflux().resize(Opm::UgGridHelpers::numFaces(grid), 0.0); + } else { + initBlackoilStateFromDeck(Opm::UgGridHelpers::numCells(grid), + Opm::UgGridHelpers::globalCell(grid), + Opm::UgGridHelpers::numFaces(grid), + Opm::UgGridHelpers::faceCells(grid), + Opm::UgGridHelpers::beginFaceCentroids(grid), + Opm::UgGridHelpers::beginCellCentroids(grid), + Opm::UgGridHelpers::dimensions(grid), + props, deck, gravity[2], state); + } + + + // The capillary pressure is scaled in new_props to match the scaled capillary pressure in props. + if (deck->hasKeyword("SWATINIT")) { + const int numCells = Opm::UgGridHelpers::numCells(grid); + std::vector cells(numCells); + for (int c = 0; c < numCells; ++c) { cells[c] = c; } + std::vector pc = state.saturation(); + props.capPress(numCells, state.saturation().data(), cells.data(), pc.data(),NULL); + new_props.setSwatInitScaling(state.saturation(),pc); + } + + bool use_gravity = (gravity[0] != 0.0 || gravity[1] != 0.0 || gravity[2] != 0.0); + const double *grav = use_gravity ? &gravity[0] : 0; + + const bool use_local_perm = param.getDefault("use_local_perm", true); + + DerivedGeology geoprops(grid, new_props, eclipseState, use_local_perm, grav); + boost::any parallel_information; + + // At this point all properties and state variables are correctly initialized + // If there are more than one processors involved, we now repartition the grid + // and initilialize new properties and states for it. + if( mpi_size > 1 ) + { + Opm::distributeGridAndData( grid, deck, eclipseState, state, new_props, geoprops, materialLawManager, parallel_information, use_local_perm ); + } + + // create output writer after grid is distributed, otherwise the parallel output + // won't work correctly since we need to create a mapping from the distributed to + // the global view + Opm::BlackoilOutputWriter outputWriter(grid, param, eclipseState, pu, new_props.permeability() ); + + // Solver for Newton iterations. + std::unique_ptr fis_solver; + { + const std::string cprSolver = "cpr"; + const std::string interleavedSolver = "interleaved"; + const std::string directSolver = "direct"; + const std::string flowDefaultSolver = interleavedSolver; + + std::shared_ptr simCfg = eclipseState->getSimulationConfig(); + std::string solver_approach = flowDefaultSolver; + + if (param.has("solver_approach")) { + solver_approach = param.get("solver_approach"); + } else { + if (simCfg->useCPR()) { + solver_approach = cprSolver; + } + } + + if (solver_approach == cprSolver) { + fis_solver.reset(new NewtonIterationBlackoilCPR(param, parallel_information)); + } else if (solver_approach == interleavedSolver) { + fis_solver.reset(new NewtonIterationBlackoilInterleaved(param, parallel_information)); + } else if (solver_approach == directSolver) { + fis_solver.reset(new NewtonIterationBlackoilSimple(param, parallel_information)); + } else { + OPM_THROW( std::runtime_error , "Internal error - solver approach " << solver_approach << " not recognized."); + } + + } + + Opm::ScheduleConstPtr schedule = eclipseState->getSchedule(); + Opm::TimeMapConstPtr timeMap(schedule->getTimeMap()); + SimulatorTimer simtimer; + + // initialize variables + simtimer.init(timeMap); + + std::map, double> maxDp; + computeMaxDp(maxDp, deck, eclipseState, grid, state, props, gravity[2]); + std::vector threshold_pressures = thresholdPressures(deck, eclipseState, grid, maxDp); + + Simulator simulator(param, + grid, + geoprops, + new_props, + rock_comp.isActive() ? &rock_comp : 0, + *fis_solver, + grav, + deck->hasKeyword("DISGAS"), + deck->hasKeyword("VAPOIL"), + eclipseState, + outputWriter, + threshold_pressures); + + if (!schedule->initOnly()){ + if( output_cout ) + { + std::cout << "\n\n================ Starting main simulation loop ===============\n" + << std::flush; + } + + SimulatorReport fullReport = simulator.run(simtimer, state); + + if( output_cout ) + { + std::cout << "\n\n================ End of simulation ===============\n\n"; + fullReport.reportFullyImplicit(std::cout); + } + + if (output) { + std::string filename = output_dir + "/walltime.txt"; + std::fstream tot_os(filename.c_str(),std::fstream::trunc | std::fstream::out); + fullReport.reportParam(tot_os); + warnIfUnusedParams(param); + } + } else { + outputWriter.writeInit( simtimer ); + if ( output_cout ) + { + std::cout << "\n\n================ Simulation turned off ===============\n" << std::flush; + } + } + return EXIT_SUCCESS; + } + catch (const std::exception &e) { + std::cerr << "Program threw an exception: " << e.what() << "\n"; + return EXIT_FAILURE; + } + + +} // namespace Opm + +#endif // OPM_FLOWMAIN_HEADER_INCLUDED From 460f0cb451bbb296352a17bb459f6e55d1a0e2dc Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Atgeirr=20Fl=C3=B8=20Rasmussen?= Date: Tue, 8 Dec 2015 10:41:30 +0100 Subject: [PATCH 5/8] Use the new flowMain() function. Also add it to the CMake file list. --- CMakeLists_files.cmake | 1 + examples/flow.cpp | 421 +---------------------------------------- examples/flow_mpi.cpp | 43 ++++- 3 files changed, 47 insertions(+), 418 deletions(-) diff --git a/CMakeLists_files.cmake b/CMakeLists_files.cmake index 9a6d831c2..61a6a2aba 100644 --- a/CMakeLists_files.cmake +++ b/CMakeLists_files.cmake @@ -141,6 +141,7 @@ list (APPEND PUBLIC_HEADER_FILES opm/autodiff/fastSparseProduct.hpp opm/autodiff/DuneMatrix.hpp opm/autodiff/ExtractParallelGridInformationToISTL.hpp + opm/autodiff/flowMain.hpp opm/autodiff/GeoProps.hpp opm/autodiff/GridHelpers.hpp opm/autodiff/GridInit.hpp diff --git a/examples/flow.cpp b/examples/flow.cpp index 7f1e05913..9e601ff66 100644 --- a/examples/flow.cpp +++ b/examples/flow.cpp @@ -1,5 +1,5 @@ /* - Copyright 2013 SINTEF ICT, Applied Mathematics. + Copyright 2013, 2014, 2015 SINTEF ICT, Applied Mathematics. Copyright 2014 Dr. Blatt - HPC-Simulation-Software & Services Copyright 2015 IRIS AS @@ -25,428 +25,17 @@ #endif // HAVE_CONFIG_H -#include - -#include - -#if DUNE_VERSION_NEWER(DUNE_COMMON, 2, 3) -#include -#else -#include -#endif - -#include - -#if HAVE_DUNE_CORNERPOINT && WANT_DUNE_CORNERPOINTGRID -#define USE_DUNE_CORNERPOINTGRID 1 -#include -#else -#undef USE_DUNE_CORNERPOINTGRID -#endif - -#include -#include -#include -#include - -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include // Note: the GridHelpers must be included before this (to make overloads available). \TODO: Fix. - -#include -#include -#include -#include - -#include -#include -#include -#include - -#include -#include - +#include #include -#include -#include -#include - -#include - -#include -#include -#include -#include -#include -#include -#include -#include - -#include -#include - -#ifdef _OPENMP -#include -#endif - -#include -#include -#include -#include -#include -#include -#include - -namespace -{ - void warnIfUnusedParams(const Opm::parameter::ParameterGroup& param) - { - if (param.anyUnused()) { - std::cout << "-------------------- Unused parameters: --------------------\n"; - param.displayUsage(); - std::cout << "----------------------------------------------------------------" << std::endl; - } - } -} // anon namespace - +#include // ----------------- Main program ----------------- int main(int argc, char** argv) -try { - using namespace Opm; - - // Must ensure an instance of the helper is created to initialise MPI. - // For a build without MPI the Dune::FakeMPIHelper is used, so rank will - // be 0 and size 1. - const Dune::MPIHelper& mpi_helper = Dune::MPIHelper::instance(argc, argv); - const int mpi_rank = mpi_helper.rank(); - const int mpi_size = mpi_helper.size(); - - // Write parameters used for later reference. (only if rank is zero) - const bool output_cout = ( mpi_rank == 0 ); - - if (output_cout) - { - std::string version = moduleVersionName(); - std::cout << "**********************************************************************\n"; - std::cout << "* *\n"; - std::cout << "* This is Flow (version " << version << ")" - << std::string(26 - version.size(), ' ') << "*\n"; - std::cout << "* *\n"; - std::cout << "* Flow is a simulator for fully implicit three-phase black-oil flow, *\n"; - std::cout << "* and is part of OPM. For more information see: *\n"; - std::cout << "* http://opm-project.org *\n"; - std::cout << "* *\n"; - std::cout << "**********************************************************************\n\n"; - } - -#ifdef _OPENMP - if (!getenv("OMP_NUM_THREADS")) { - //Default to at most 4 threads, regardless of - //number of cores (unless ENV(OMP_NUM_THREADS) is defined) - int num_cores = omp_get_num_procs(); - int num_threads = std::min(4, num_cores); - omp_set_num_threads(num_threads); - } -#pragma omp parallel - if (omp_get_thread_num() == 0){ - //opm_get_num_threads() only works as expected within a parallel region. - std::cout << "OpenMP using " << omp_get_num_threads() << " threads." << std::endl; - } -#endif - - // Read parameters, see if a deck was specified on the command line. - if ( output_cout ) - { - std::cout << "--------------- Reading parameters ---------------" << std::endl; - } - - parameter::ParameterGroup param(argc, argv, false, output_cout); - if( !output_cout ) - { - param.disableOutput(); - } - - if (!param.unhandledArguments().empty()) { - if (param.unhandledArguments().size() != 1) { - std::cerr << "You can only specify a single input deck on the command line.\n"; - return EXIT_FAILURE; - } else { - param.insertParameter("deck_filename", param.unhandledArguments()[0]); - } - } - - // We must have an input deck. Grid and props will be read from that. - if (!param.has("deck_filename")) { - std::cerr << "This program must be run with an input deck.\n" - "Specify the deck filename either\n" - " a) as a command line argument by itself\n" - " b) as a command line parameter with the syntax deck_filename=, or\n" - " c) as a parameter in a parameter file (.param or .xml) passed to the program.\n"; - return EXIT_FAILURE; - } - - // bool check_well_controls = false; - // int max_well_control_iterations = 0; - double gravity[3] = { 0.0 }; - std::string deck_filename = param.get("deck_filename"); - - // Write parameters used for later reference. (only if rank is zero) - bool output = ( mpi_rank == 0 ) && param.getDefault("output", true); - std::string output_dir; - if (output) { - // Create output directory if needed. - output_dir = - param.getDefault("output_dir", std::string("output")); - boost::filesystem::path fpath(output_dir); - try { - create_directories(fpath); - } - catch (...) { - std::cerr << "Creating directories failed: " << fpath << std::endl; - return EXIT_FAILURE; - } - // Write simulation parameters. - param.writeParam(output_dir + "/simulation.param"); - } - - std::string logFile = output_dir + "/LOGFILE.txt"; - Opm::ParserPtr parser(new Opm::Parser()); - { - std::shared_ptr streamLog = std::make_shared(logFile , Opm::Log::DefaultMessageTypes); - std::shared_ptr counterLog = std::make_shared(Opm::Log::DefaultMessageTypes); - - Opm::OpmLog::addBackend( "STREAM" , streamLog ); - Opm::OpmLog::addBackend( "COUNTER" , counterLog ); - } - - Opm::ParseMode parseMode({{ ParseMode::PARSE_RANDOM_SLASH , InputError::IGNORE }}); - Opm::DeckConstPtr deck; - std::shared_ptr eclipseState; - try { - deck = parser->parseFile(deck_filename, parseMode); - Opm::checkDeck(deck); - eclipseState.reset(new Opm::EclipseState(deck , parseMode)); - } - catch (const std::invalid_argument& e) { - std::cerr << "Failed to create valid ECLIPSESTATE object. See logfile: " << logFile << std::endl; - std::cerr << "Exception caught: " << e.what() << std::endl; - return EXIT_FAILURE; - } - - std::vector porv = eclipseState->getDoubleGridProperty("PORV")->getData(); -#if USE_DUNE_CORNERPOINTGRID - typedef Dune::CpGrid Grid; -#else typedef UnstructuredGrid Grid; -#endif - GridInit grid_init(deck, eclipseState, porv); - auto&& grid = grid_init.grid(); + typedef Opm::SimulatorFullyImplicitBlackoil Simulator; - // Possibly override IOConfig setting (from deck) for how often RESTART files should get written to disk (every N report step) - if (param.has("output_interval")) { - int output_interval = param.get("output_interval"); - IOConfigPtr ioConfig = eclipseState->getIOConfig(); - ioConfig->overrideRestartWriteInterval((size_t)output_interval); - } - - const PhaseUsage pu = Opm::phaseUsageFromDeck(deck); - - std::vector compressedToCartesianIdx; - Opm::createGlobalCellArray(grid, compressedToCartesianIdx); - - typedef BlackoilPropsAdFromDeck::MaterialLawManager MaterialLawManager; - auto materialLawManager = std::make_shared(); - materialLawManager->initFromDeck(deck, eclipseState, compressedToCartesianIdx); - - // Rock and fluid init - BlackoilPropertiesFromDeck props( deck, eclipseState, materialLawManager, - Opm::UgGridHelpers::numCells(grid), - Opm::UgGridHelpers::globalCell(grid), - Opm::UgGridHelpers::cartDims(grid), - param); - - BlackoilPropsAdFromDeck new_props( deck, eclipseState, materialLawManager, grid ); - // check_well_controls = param.getDefault("check_well_controls", false); - // max_well_control_iterations = param.getDefault("max_well_control_iterations", 10); - // Rock compressibility. - - RockCompressibility rock_comp(deck, eclipseState); - - // Gravity. - gravity[2] = deck->hasKeyword("NOGRAV") ? 0.0 : unit::gravity; - - BlackoilState state; - // Init state variables (saturation and pressure). - if (param.has("init_saturation")) { - initStateBasic(Opm::UgGridHelpers::numCells(grid), - Opm::UgGridHelpers::globalCell(grid), - Opm::UgGridHelpers::cartDims(grid), - Opm::UgGridHelpers::numFaces(grid), - Opm::UgGridHelpers::faceCells(grid), - Opm::UgGridHelpers::beginFaceCentroids(grid), - Opm::UgGridHelpers::beginCellCentroids(grid), - Opm::UgGridHelpers::dimensions(grid), - props, param, gravity[2], state); - - initBlackoilSurfvol(Opm::UgGridHelpers::numCells(grid), props, state); - - enum { Oil = BlackoilPhases::Liquid, Gas = BlackoilPhases::Vapour }; - if (pu.phase_used[Oil] && pu.phase_used[Gas]) { - const int numPhases = props.numPhases(); - const int numCells = Opm::UgGridHelpers::numCells(grid); - for (int c = 0; c < numCells; ++c) { - state.gasoilratio()[c] = state.surfacevol()[c*numPhases + pu.phase_pos[Gas]] - / state.surfacevol()[c*numPhases + pu.phase_pos[Oil]]; - } - } - } else if (deck->hasKeyword("EQUIL") && props.numPhases() == 3) { - state.init(Opm::UgGridHelpers::numCells(grid), - Opm::UgGridHelpers::numFaces(grid), - props.numPhases()); - const double grav = param.getDefault("gravity", unit::gravity); - initStateEquil(grid, props, deck, eclipseState, grav, state); - state.faceflux().resize(Opm::UgGridHelpers::numFaces(grid), 0.0); - } else { - initBlackoilStateFromDeck(Opm::UgGridHelpers::numCells(grid), - Opm::UgGridHelpers::globalCell(grid), - Opm::UgGridHelpers::numFaces(grid), - Opm::UgGridHelpers::faceCells(grid), - Opm::UgGridHelpers::beginFaceCentroids(grid), - Opm::UgGridHelpers::beginCellCentroids(grid), - Opm::UgGridHelpers::dimensions(grid), - props, deck, gravity[2], state); - } - - - // The capillary pressure is scaled in new_props to match the scaled capillary pressure in props. - if (deck->hasKeyword("SWATINIT")) { - const int numCells = Opm::UgGridHelpers::numCells(grid); - std::vector cells(numCells); - for (int c = 0; c < numCells; ++c) { cells[c] = c; } - std::vector pc = state.saturation(); - props.capPress(numCells, state.saturation().data(), cells.data(), pc.data(),NULL); - new_props.setSwatInitScaling(state.saturation(),pc); - } - - bool use_gravity = (gravity[0] != 0.0 || gravity[1] != 0.0 || gravity[2] != 0.0); - const double *grav = use_gravity ? &gravity[0] : 0; - - const bool use_local_perm = param.getDefault("use_local_perm", true); - - DerivedGeology geoprops(grid, new_props, eclipseState, use_local_perm, grav); - boost::any parallel_information; - - // At this point all properties and state variables are correctly initialized - // If there are more than one processors involved, we now repartition the grid - // and initilialize new properties and states for it. - if( mpi_size > 1 ) - { - Opm::distributeGridAndData( grid, deck, eclipseState, state, new_props, geoprops, materialLawManager, parallel_information, use_local_perm ); - } - - // create output writer after grid is distributed, otherwise the parallel output - // won't work correctly since we need to create a mapping from the distributed to - // the global view - Opm::BlackoilOutputWriter outputWriter(grid, param, eclipseState, pu, new_props.permeability() ); - - // Solver for Newton iterations. - std::unique_ptr fis_solver; - { - const std::string cprSolver = "cpr"; - const std::string interleavedSolver = "interleaved"; - const std::string directSolver = "direct"; - const std::string flowDefaultSolver = interleavedSolver; - - std::shared_ptr simCfg = eclipseState->getSimulationConfig(); - std::string solver_approach = flowDefaultSolver; - - if (param.has("solver_approach")) { - solver_approach = param.get("solver_approach"); - } else { - if (simCfg->useCPR()) { - solver_approach = cprSolver; - } - } - - if (solver_approach == cprSolver) { - fis_solver.reset(new NewtonIterationBlackoilCPR(param, parallel_information)); - } else if (solver_approach == interleavedSolver) { - fis_solver.reset(new NewtonIterationBlackoilInterleaved(param, parallel_information)); - } else if (solver_approach == directSolver) { - fis_solver.reset(new NewtonIterationBlackoilSimple(param, parallel_information)); - } else { - OPM_THROW( std::runtime_error , "Internal error - solver approach " << solver_approach << " not recognized."); - } - - } - - Opm::ScheduleConstPtr schedule = eclipseState->getSchedule(); - Opm::TimeMapConstPtr timeMap(schedule->getTimeMap()); - SimulatorTimer simtimer; - - // initialize variables - simtimer.init(timeMap); - - std::map, double> maxDp; - computeMaxDp(maxDp, deck, eclipseState, grid, state, props, gravity[2]); - std::vector threshold_pressures = thresholdPressures(deck, eclipseState, grid, maxDp); - std::vector threshold_pressures_nnc = thresholdPressuresNNC(eclipseState, geoprops.nnc(), maxDp); - threshold_pressures.insert(threshold_pressures.begin(), threshold_pressures_nnc.begin(), threshold_pressures_nnc.end()); - SimulatorFullyImplicitBlackoil< Grid > simulator(param, - grid, - geoprops, - new_props, - rock_comp.isActive() ? &rock_comp : 0, - *fis_solver, - grav, - deck->hasKeyword("DISGAS"), - deck->hasKeyword("VAPOIL"), - eclipseState, - outputWriter, - threshold_pressures); - - if (!schedule->initOnly()){ - if( output_cout ) - { - std::cout << "\n\n================ Starting main simulation loop ===============\n" - << std::flush; - } - - SimulatorReport fullReport = simulator.run(simtimer, state); - - if( output_cout ) - { - std::cout << "\n\n================ End of simulation ===============\n\n"; - fullReport.reportFullyImplicit(std::cout); - } - - if (output) { - std::string filename = output_dir + "/walltime.txt"; - std::fstream tot_os(filename.c_str(),std::fstream::trunc | std::fstream::out); - fullReport.reportParam(tot_os); - warnIfUnusedParams(param); - } - } else { - outputWriter.writeInit( simtimer ); - if ( output_cout ) - { - std::cout << "\n\n================ Simulation turned off ===============\n" << std::flush; - } - } + return Opm::flowMain(argc, argv); } -catch (const std::exception &e) { - std::cerr << "Program threw an exception: " << e.what() << "\n"; - return EXIT_FAILURE; -} - diff --git a/examples/flow_mpi.cpp b/examples/flow_mpi.cpp index 628a3ea84..c68e850d4 100644 --- a/examples/flow_mpi.cpp +++ b/examples/flow_mpi.cpp @@ -1,2 +1,41 @@ -#define WANT_DUNE_CORNERPOINTGRID 1 -#include "flow.cpp" +/* + Copyright 2013, 2014, 2015 SINTEF ICT, Applied Mathematics. + Copyright 2014 Dr. Blatt - HPC-Simulation-Software & Services + Copyright 2015 IRIS AS + + This file is part of the Open Porous Media project (OPM). + + OPM is free software: you can redistribute it and/or modify + it under the terms of the GNU General Public License as published by + the Free Software Foundation, either version 3 of the License, or + (at your option) any later version. + + OPM is distributed in the hope that it will be useful, + but WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the + GNU General Public License for more details. + + You should have received a copy of the GNU General Public License + along with OPM. If not, see . +*/ + + +#if HAVE_CONFIG_H +#include "config.h" +#endif // HAVE_CONFIG_H + + +#include +#include +#include + + +// ----------------- Main program ----------------- +int +main(int argc, char** argv) +{ + typedef Dune::CpGrid Grid; + typedef Opm::SimulatorFullyImplicitBlackoil Simulator; + + return Opm::flowMain(argc, argv); +} From f02fd71404f254e1a37e98d5587913b1cab5351a Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Atgeirr=20Fl=C3=B8=20Rasmussen?= Date: Tue, 8 Dec 2015 11:32:47 +0100 Subject: [PATCH 6/8] Use Simulator::ReservoirState in flowMain(). --- opm/autodiff/flowMain.hpp | 3 +-- 1 file changed, 1 insertion(+), 2 deletions(-) diff --git a/opm/autodiff/flowMain.hpp b/opm/autodiff/flowMain.hpp index 3ae9855c8..1add4c8a1 100644 --- a/opm/autodiff/flowMain.hpp +++ b/opm/autodiff/flowMain.hpp @@ -62,7 +62,6 @@ #include #include -#include #include #include @@ -275,7 +274,7 @@ namespace Opm // Gravity. gravity[2] = deck->hasKeyword("NOGRAV") ? 0.0 : unit::gravity; - BlackoilState state; + typename Simulator::ReservoirState state; // Init state variables (saturation and pressure). if (param.has("init_saturation")) { initStateBasic(Opm::UgGridHelpers::numCells(grid), From 29d18261c62648952bff65638b5a6693e93e0207 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Atgeirr=20Fl=C3=B8=20Rasmussen?= Date: Tue, 8 Dec 2015 12:52:51 +0100 Subject: [PATCH 7/8] Make multisegment flow variants use flowMain(). --- examples/flow_multisegment.cpp | 434 +----------------- examples/flow_multisegment_mpi.cpp | 43 +- ...latorFullyImplicitBlackoilMultiSegment.hpp | 3 +- 3 files changed, 48 insertions(+), 432 deletions(-) diff --git a/examples/flow_multisegment.cpp b/examples/flow_multisegment.cpp index 8d36bd807..feec4346d 100644 --- a/examples/flow_multisegment.cpp +++ b/examples/flow_multisegment.cpp @@ -1,5 +1,5 @@ /* - Copyright 2013 SINTEF ICT, Applied Mathematics. + Copyright 2013, 2014, 2015 SINTEF ICT, Applied Mathematics. Copyright 2014 Dr. Blatt - HPC-Simulation-Software & Services Copyright 2015 IRIS AS @@ -25,441 +25,17 @@ #endif // HAVE_CONFIG_H -#include - -#include - -#if DUNE_VERSION_NEWER(DUNE_COMMON, 2, 3) -#include -#else -#include -#endif - -#if HAVE_DUNE_CORNERPOINT && WANT_DUNE_CORNERPOINTGRID -#define USE_DUNE_CORNERPOINTGRID 1 -#include -#include -#else -#undef USE_DUNE_CORNERPOINTGRID -#endif - -#include - -#include - #include -#include -#include -#include -#include - -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include // Note: the GridHelpers must be included before this (to make overloads available). \TODO: Fix. - -#include -#include -#include -#include - -#include -#include -#include -#include - -#include -#include - #include -#include -#include -#include - -#include - -#include -#include -#include -#include -#include -#include -#include -#include - -#include -#include - -#ifdef _OPENMP -#include -#endif - -#include -#include -#include -#include -#include -#include -#include - -namespace -{ - void warnIfUnusedParams(const Opm::parameter::ParameterGroup& param) - { - if (param.anyUnused()) { - std::cout << "-------------------- Unused parameters: --------------------\n"; - param.displayUsage(); - std::cout << "----------------------------------------------------------------" << std::endl; - } - } -} // anon namespace - +#include // ----------------- Main program ----------------- int main(int argc, char** argv) -try { - using namespace Opm; -#if USE_DUNE_CORNERPOINTGRID - // Must ensure an instance of the helper is created to initialise MPI. - const Dune::MPIHelper& mpi_helper = Dune::MPIHelper::instance(argc, argv); - const int mpi_rank = mpi_helper.rank(); - const int mpi_size = mpi_helper.size(); -#else - // default values for serial run - const int mpi_rank = 0; - const int mpi_size = 1; -#endif + typedef UnstructuredGrid Grid; + typedef Opm::SimulatorFullyImplicitBlackoilMultiSegment Simulator; - // Write parameters used for later reference. (only if rank is zero) - const bool output_cout = ( mpi_rank == 0 ); - - if (output_cout) - { - std::string version = moduleVersionName(); - std::cout << "**********************************************************************\n"; - std::cout << "* *\n"; - std::cout << "* This is Flow (version " << version << ")" - << std::string(26 - version.size(), ' ') << "*\n"; - std::cout << "* *\n"; - std::cout << "* Flow is a simulator for fully implicit three-phase black-oil flow, *\n"; - std::cout << "* and is part of OPM. For more information see: *\n"; - std::cout << "* http://opm-project.org *\n"; - std::cout << "* *\n"; - std::cout << "**********************************************************************\n\n"; - } - -#ifdef _OPENMP - if (!getenv("OMP_NUM_THREADS")) { - //Default to at most 4 threads, regardless of - //number of cores (unless ENV(OMP_NUM_THREADS) is defined) - int num_cores = omp_get_num_procs(); - int num_threads = std::min(4, num_cores); - omp_set_num_threads(num_threads); - } -#pragma omp parallel - if (omp_get_thread_num() == 0){ - //opm_get_num_threads() only works as expected within a parallel region. - std::cout << "OpenMP using " << omp_get_num_threads() << " threads." << std::endl; - } -#endif - - // Read parameters, see if a deck was specified on the command line. - if ( output_cout ) - { - std::cout << "--------------- Reading parameters ---------------" << std::endl; - } - - parameter::ParameterGroup param(argc, argv, false, output_cout); - if( !output_cout ) - { - param.disableOutput(); - } - - if (!param.unhandledArguments().empty()) { - if (param.unhandledArguments().size() != 1) { - std::cerr << "You can only specify a single input deck on the command line.\n"; - return EXIT_FAILURE; - } else { - param.insertParameter("deck_filename", param.unhandledArguments()[0]); - } - } - - // We must have an input deck. Grid and props will be read from that. - if (!param.has("deck_filename")) { - std::cerr << "This program must be run with an input deck.\n" - "Specify the deck filename either\n" - " a) as a command line argument by itself\n" - " b) as a command line parameter with the syntax deck_filename=, or\n" - " c) as a parameter in a parameter file (.param or .xml) passed to the program.\n"; - return EXIT_FAILURE; - } - - // bool check_well_controls = false; - // int max_well_control_iterations = 0; - double gravity[3] = { 0.0 }; - std::string deck_filename = param.get("deck_filename"); - - // Write parameters used for later reference. (only if rank is zero) - bool output = ( mpi_rank == 0 ) && param.getDefault("output", true); - std::string output_dir; - if (output) { - // Create output directory if needed. - output_dir = - param.getDefault("output_dir", std::string("output")); - boost::filesystem::path fpath(output_dir); - try { - create_directories(fpath); - } - catch (...) { - std::cerr << "Creating directories failed: " << fpath << std::endl; - return EXIT_FAILURE; - } - // Write simulation parameters. - param.writeParam(output_dir + "/simulation.param"); - } - - std::string logFile = output_dir + "/LOGFILE.txt"; - Opm::ParserPtr parser(new Opm::Parser()); - { - std::shared_ptr streamLog = std::make_shared(logFile , Opm::Log::DefaultMessageTypes); - std::shared_ptr counterLog = std::make_shared(Opm::Log::DefaultMessageTypes); - - Opm::OpmLog::addBackend( "STREAM" , streamLog ); - Opm::OpmLog::addBackend( "COUNTER" , counterLog ); - } - - Opm::ParseMode parseMode({{ ParseMode::PARSE_RANDOM_SLASH , InputError::IGNORE }}); - Opm::DeckConstPtr deck; - std::shared_ptr eclipseState; - try { - deck = parser->parseFile(deck_filename, parseMode); - Opm::checkDeck(deck); - eclipseState.reset(new Opm::EclipseState(deck , parseMode)); - } - catch (const std::invalid_argument& e) { - std::cerr << "Failed to create valid ECLIPSESTATE object. See logfile: " << logFile << std::endl; - std::cerr << "Exception caught: " << e.what() << std::endl; - return EXIT_FAILURE; - } - - std::vector porv = eclipseState->getDoubleGridProperty("PORV")->getData(); -#if USE_DUNE_CORNERPOINTGRID - // Dune::CpGrid as grid manager - typedef Dune::CpGrid Grid; - // Grid init - Grid grid; - grid.processEclipseFormat(deck, false, false, false, porv); -#else - // UnstructuredGrid as grid manager - typedef UnstructuredGrid Grid; - GridManager gridManager( eclipseState->getEclipseGrid(), porv ); - const Grid& grid = *(gridManager.c_grid()); -#endif - - // Possibly override IOConfig setting (from deck) for how often RESTART files should get written to disk (every N report step) - if (param.has("output_interval")) { - int output_interval = param.get("output_interval"); - IOConfigPtr ioConfig = eclipseState->getIOConfig(); - ioConfig->overrideRestartWriteInterval((size_t)output_interval); - } - - const PhaseUsage pu = Opm::phaseUsageFromDeck(deck); - - std::vector compressedToCartesianIdx; - Opm::createGlobalCellArray(grid, compressedToCartesianIdx); - - typedef BlackoilPropsAdFromDeck::MaterialLawManager MaterialLawManager; - auto materialLawManager = std::make_shared(); - materialLawManager->initFromDeck(deck, eclipseState, compressedToCartesianIdx); - - // Rock and fluid init - BlackoilPropertiesFromDeck props( deck, eclipseState, materialLawManager, - Opm::UgGridHelpers::numCells(grid), - Opm::UgGridHelpers::globalCell(grid), - Opm::UgGridHelpers::cartDims(grid), - param); - - BlackoilPropsAdFromDeck new_props( deck, eclipseState, materialLawManager, grid ); - // check_well_controls = param.getDefault("check_well_controls", false); - // max_well_control_iterations = param.getDefault("max_well_control_iterations", 10); - // Rock compressibility. - - RockCompressibility rock_comp(deck, eclipseState); - - // Gravity. - gravity[2] = deck->hasKeyword("NOGRAV") ? 0.0 : unit::gravity; - - BlackoilState state; - // Init state variables (saturation and pressure). - if (param.has("init_saturation")) { - initStateBasic(Opm::UgGridHelpers::numCells(grid), - Opm::UgGridHelpers::globalCell(grid), - Opm::UgGridHelpers::cartDims(grid), - Opm::UgGridHelpers::numFaces(grid), - Opm::UgGridHelpers::faceCells(grid), - Opm::UgGridHelpers::beginFaceCentroids(grid), - Opm::UgGridHelpers::beginCellCentroids(grid), - Opm::UgGridHelpers::dimensions(grid), - props, param, gravity[2], state); - - initBlackoilSurfvol(Opm::UgGridHelpers::numCells(grid), props, state); - - enum { Oil = BlackoilPhases::Liquid, Gas = BlackoilPhases::Vapour }; - if (pu.phase_used[Oil] && pu.phase_used[Gas]) { - const int numPhases = props.numPhases(); - const int numCells = Opm::UgGridHelpers::numCells(grid); - for (int c = 0; c < numCells; ++c) { - state.gasoilratio()[c] = state.surfacevol()[c*numPhases + pu.phase_pos[Gas]] - / state.surfacevol()[c*numPhases + pu.phase_pos[Oil]]; - } - } - } else if (deck->hasKeyword("EQUIL") && props.numPhases() == 3) { - state.init(Opm::UgGridHelpers::numCells(grid), - Opm::UgGridHelpers::numFaces(grid), - props.numPhases()); - const double grav = param.getDefault("gravity", unit::gravity); - initStateEquil(grid, props, deck, eclipseState, grav, state); - state.faceflux().resize(Opm::UgGridHelpers::numFaces(grid), 0.0); - } else { - initBlackoilStateFromDeck(Opm::UgGridHelpers::numCells(grid), - Opm::UgGridHelpers::globalCell(grid), - Opm::UgGridHelpers::numFaces(grid), - Opm::UgGridHelpers::faceCells(grid), - Opm::UgGridHelpers::beginFaceCentroids(grid), - Opm::UgGridHelpers::beginCellCentroids(grid), - Opm::UgGridHelpers::dimensions(grid), - props, deck, gravity[2], state); - } - - - // The capillary pressure is scaled in new_props to match the scaled capillary pressure in props. - if (deck->hasKeyword("SWATINIT")) { - const int numCells = Opm::UgGridHelpers::numCells(grid); - std::vector cells(numCells); - for (int c = 0; c < numCells; ++c) { cells[c] = c; } - std::vector pc = state.saturation(); - props.capPress(numCells, state.saturation().data(), cells.data(), pc.data(),NULL); - new_props.setSwatInitScaling(state.saturation(),pc); - } - - bool use_gravity = (gravity[0] != 0.0 || gravity[1] != 0.0 || gravity[2] != 0.0); - const double *grav = use_gravity ? &gravity[0] : 0; - - const bool use_local_perm = param.getDefault("use_local_perm", true); - - DerivedGeology geoprops(grid, new_props, eclipseState, use_local_perm, grav); - boost::any parallel_information; - - // At this point all properties and state variables are correctly initialized - // If there are more than one processors involved, we now repartition the grid - // and initilialize new properties and states for it. - if( mpi_size > 1 ) - { - Opm::distributeGridAndData( grid, deck, eclipseState, state, new_props, geoprops, materialLawManager, parallel_information, use_local_perm ); - } - - // create output writer after grid is distributed, otherwise the parallel output - // won't work correctly since we need to create a mapping from the distributed to - // the global view - Opm::BlackoilOutputWriter outputWriter(grid, param, eclipseState, pu, new_props.permeability() ); - - // Solver for Newton iterations. - std::unique_ptr fis_solver; - { - const std::string cprSolver = "cpr"; - const std::string interleavedSolver = "interleaved"; - const std::string directSolver = "direct"; - const std::string flowDefaultSolver = interleavedSolver; - - std::shared_ptr simCfg = eclipseState->getSimulationConfig(); - std::string solver_approach = flowDefaultSolver; - - if (param.has("solver_approach")) { - solver_approach = param.get("solver_approach"); - } else { - if (simCfg->useCPR()) { - solver_approach = cprSolver; - } - } - - if (solver_approach == cprSolver) { - fis_solver.reset(new NewtonIterationBlackoilCPR(param, parallel_information)); - } else if (solver_approach == interleavedSolver) { - fis_solver.reset(new NewtonIterationBlackoilInterleaved(param, parallel_information)); - } else if (solver_approach == directSolver) { - fis_solver.reset(new NewtonIterationBlackoilSimple(param, parallel_information)); - } else { - OPM_THROW( std::runtime_error , "Internal error - solver approach " << solver_approach << " not recognized."); - } - - } - - Opm::ScheduleConstPtr schedule = eclipseState->getSchedule(); - Opm::TimeMapConstPtr timeMap(schedule->getTimeMap()); - SimulatorTimer simtimer; - - // initialize variables - simtimer.init(timeMap); - - std::map, double> maxDp; - computeMaxDp(maxDp, deck, eclipseState, grid, state, props, gravity[2]); - std::vector threshold_pressures = thresholdPressures(deck, eclipseState, grid, maxDp); - std::vector threshold_pressures_nnc = thresholdPressuresNNC(eclipseState, geoprops.nnc(), maxDp); - threshold_pressures.insert(threshold_pressures.begin(), threshold_pressures_nnc.begin(), threshold_pressures_nnc.end()); - - SimulatorFullyImplicitBlackoilMultiSegment< Grid > simulator(param, - grid, - geoprops, - new_props, - rock_comp.isActive() ? &rock_comp : 0, - *fis_solver, - grav, - deck->hasKeyword("DISGAS"), - deck->hasKeyword("VAPOIL"), - eclipseState, - outputWriter, - threshold_pressures); - - if (!schedule->initOnly()){ - if( output_cout ) - { - std::cout << "\n\n================ Starting main simulation loop ===============\n" - << std::flush; - } - - SimulatorReport fullReport = simulator.run(simtimer, state); - - if( output_cout ) - { - std::cout << "\n\n================ End of simulation ===============\n\n"; - fullReport.reportFullyImplicit(std::cout); - } - - if (output) { - std::string filename = output_dir + "/walltime.txt"; - std::fstream tot_os(filename.c_str(),std::fstream::trunc | std::fstream::out); - fullReport.reportParam(tot_os); - warnIfUnusedParams(param); - } - } else { - outputWriter.writeInit( simtimer ); - if ( output_cout ) - { - std::cout << "\n\n================ Simulation turned off ===============\n" << std::flush; - } - } + return Opm::flowMain(argc, argv); } -catch (const std::exception &e) { - std::cerr << "Program threw an exception: " << e.what() << "\n"; - return EXIT_FAILURE; -} - diff --git a/examples/flow_multisegment_mpi.cpp b/examples/flow_multisegment_mpi.cpp index b54903ef6..5525e0658 100644 --- a/examples/flow_multisegment_mpi.cpp +++ b/examples/flow_multisegment_mpi.cpp @@ -1,2 +1,41 @@ -#define WANT_DUNE_CORNERPOINTGRID 1 -#include "flow_multisegment.cpp" +/* + Copyright 2013, 2014, 2015 SINTEF ICT, Applied Mathematics. + Copyright 2014 Dr. Blatt - HPC-Simulation-Software & Services + Copyright 2015 IRIS AS + + This file is part of the Open Porous Media project (OPM). + + OPM is free software: you can redistribute it and/or modify + it under the terms of the GNU General Public License as published by + the Free Software Foundation, either version 3 of the License, or + (at your option) any later version. + + OPM is distributed in the hope that it will be useful, + but WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the + GNU General Public License for more details. + + You should have received a copy of the GNU General Public License + along with OPM. If not, see . +*/ + + +#if HAVE_CONFIG_H +#include "config.h" +#endif // HAVE_CONFIG_H + + +#include +#include +#include + + +// ----------------- Main program ----------------- +int +main(int argc, char** argv) +{ + typedef Dune::CpGrid Grid; + typedef Opm::SimulatorFullyImplicitBlackoilMultiSegment Simulator; + + return Opm::flowMain(argc, argv); +} diff --git a/opm/autodiff/SimulatorFullyImplicitBlackoilMultiSegment.hpp b/opm/autodiff/SimulatorFullyImplicitBlackoilMultiSegment.hpp index edac5d653..4d559ca74 100644 --- a/opm/autodiff/SimulatorFullyImplicitBlackoilMultiSegment.hpp +++ b/opm/autodiff/SimulatorFullyImplicitBlackoilMultiSegment.hpp @@ -49,13 +49,14 @@ template class SimulatorFullyImplicitBlackoilMultiSegment : public SimulatorBase > { +public: typedef SimulatorBase > Base; typedef SimulatorFullyImplicitBlackoilMultiSegment ThisType; typedef SimulatorTraits Traits; typedef typename Traits::ReservoirState ReservoirState; typedef typename Traits::WellState WellState; typedef typename Traits::Solver Solver; -public: + // forward the constructor to the base class SimulatorFullyImplicitBlackoilMultiSegment(const parameter::ParameterGroup& param, const GridT& grid, From b10b028aa1239583584705a7279d714d6f605948 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Atgeirr=20Fl=C3=B8=20Rasmussen?= Date: Wed, 9 Dec 2015 10:09:49 +0100 Subject: [PATCH 8/8] Documented flowMain(). --- opm/autodiff/flowMain.hpp | 5 +++++ 1 file changed, 5 insertions(+) diff --git a/opm/autodiff/flowMain.hpp b/opm/autodiff/flowMain.hpp index 1add4c8a1..76647abd4 100644 --- a/opm/autodiff/flowMain.hpp +++ b/opm/autodiff/flowMain.hpp @@ -113,6 +113,11 @@ namespace Opm } + /// This is the main function of Flow. + /// It runs a complete simulation, with the given grid and + /// simulator classes, based on user command-line input. The + /// content of this function used to be in the main() function of + /// flow.cpp. template inline int flowMain(int argc, char** argv) try {