2 * This file is part of the GROMACS molecular simulation package.
4 * Copyright (c) 2010,2011,2012,2013,2014,2015,2016, by the GROMACS development team, led by
5 * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
6 * and including many others, as listed in the AUTHORS file in the
7 * top-level source directory and at http://www.gromacs.org.
9 * GROMACS is free software; you can redistribute it and/or
10 * modify it under the terms of the GNU Lesser General Public License
11 * as published by the Free Software Foundation; either version 2.1
12 * of the License, or (at your option) any later version.
14 * GROMACS is distributed in the hope that it will be useful,
15 * but WITHOUT ANY WARRANTY; without even the implied warranty of
16 * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
17 * Lesser General Public License for more details.
19 * You should have received a copy of the GNU Lesser General Public
20 * License along with GROMACS; if not, see
21 * http://www.gnu.org/licenses, or write to the Free Software Foundation,
22 * Inc., 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA.
24 * If you want to redistribute modifications to GROMACS, please
25 * consider that scientific software is very special. Version
26 * control is crucial - bugs must be traceable. We will be happy to
27 * consider code for inclusion in the official distribution, but
28 * derived work must not be called official GROMACS. Details are found
29 * in the README & COPYING files - if they are missing, get the
30 * official version at http://www.gromacs.org.
32 * To help us fund GROMACS development, we humbly ask that you cite
33 * the research papers on the package. Check out http://www.gromacs.org.
37 * Implements gmx::TrajectoryAnalysisRunnerCommon.
39 * \author Teemu Murtola <teemu.murtola@gmail.com>
40 * \ingroup module_trajectoryanalysis
44 #include "runnercommon.h"
51 #include "gromacs/fileio/confio.h"
52 #include "gromacs/fileio/oenv.h"
53 #include "gromacs/fileio/timecontrol.h"
54 #include "gromacs/fileio/trxio.h"
55 #include "gromacs/math/vec.h"
56 #include "gromacs/options/basicoptions.h"
57 #include "gromacs/options/filenameoption.h"
58 #include "gromacs/options/ioptionscontainer.h"
59 #include "gromacs/pbcutil/rmpbc.h"
60 #include "gromacs/selection/selection.h"
61 #include "gromacs/selection/selectioncollection.h"
62 #include "gromacs/selection/selectionoption.h"
63 #include "gromacs/selection/selectionoptionbehavior.h"
64 #include "gromacs/topology/topology.h"
65 #include "gromacs/trajectory/trajectoryframe.h"
66 #include "gromacs/trajectoryanalysis/analysissettings.h"
67 #include "gromacs/utility/cstringutil.h"
68 #include "gromacs/utility/exceptions.h"
69 #include "gromacs/utility/gmxassert.h"
70 #include "gromacs/utility/programcontext.h"
71 #include "gromacs/utility/smalloc.h"
72 #include "gromacs/utility/stringutil.h"
74 #include "analysissettings-impl.h"
79 class TrajectoryAnalysisRunnerCommon::Impl
: public ITopologyProvider
82 Impl(TrajectoryAnalysisSettings
*settings
);
85 bool hasTrajectory() const { return !trjfile_
.empty(); }
87 void initTopology(bool required
);
88 void initFirstFrame();
89 void initFrameIndexGroup();
90 void finishTrajectory();
92 // From ITopologyProvider
93 virtual t_topology
*getTopology(bool required
)
95 initTopology(required
);
96 return topInfo_
.topology();
98 virtual int getAtomCount()
100 if (!topInfo_
.hasTopology())
102 if (trajectoryGroup_
.isValid())
104 GMX_THROW(InconsistentInputError("-fgroup is only supported when -s is also specified"));
106 // Read the first frame if we don't know the maximum number of
114 TrajectoryAnalysisSettings
&settings_
;
115 TopologyInformation topInfo_
;
117 //! Name of the trajectory file (empty if not provided).
118 std::string trjfile_
;
119 //! Name of the topology file (empty if no topology provided).
120 std::string topfile_
;
121 Selection trajectoryGroup_
;
130 //! The current frame, or \p NULL if no frame loaded yet.
133 //! Used to store the status variable from read_first_frame().
134 t_trxstatus
*status_
;
135 gmx_output_env_t
*oenv_
;
139 TrajectoryAnalysisRunnerCommon::Impl::Impl(TrajectoryAnalysisSettings
*settings
)
140 : settings_(*settings
),
141 startTime_(0.0), endTime_(0.0), deltaTime_(0.0),
142 bStartTimeSet_(false), bEndTimeSet_(false), bDeltaTimeSet_(false),
143 bTrajOpen_(false), fr(NULL
), gpbc_(NULL
), status_(NULL
), oenv_(NULL
)
148 TrajectoryAnalysisRunnerCommon::Impl::~Impl()
153 // There doesn't seem to be a function for freeing frame data
160 if (oenv_
!= nullptr)
162 output_env_done(oenv_
);
167 TrajectoryAnalysisRunnerCommon::Impl::initTopology(bool required
)
169 // Return immediately if the topology has already been loaded.
170 if (topInfo_
.hasTopology())
175 if (required
&& topfile_
.empty())
177 GMX_THROW(InconsistentInputError("No topology provided, but one is required for analysis"));
180 // Load the topology if requested.
181 if (!topfile_
.empty())
183 snew(topInfo_
.top_
, 1);
184 topInfo_
.bTop_
= read_tps_conf(topfile_
.c_str(), topInfo_
.top_
, &topInfo_
.ePBC_
,
185 &topInfo_
.xtop_
, NULL
, topInfo_
.boxtop_
, TRUE
);
187 && !settings_
.hasFlag(TrajectoryAnalysisSettings::efUseTopX
))
189 sfree(topInfo_
.xtop_
);
190 topInfo_
.xtop_
= NULL
;
196 TrajectoryAnalysisRunnerCommon::Impl::initFirstFrame()
198 // Return if we have already initialized the trajectory.
203 time_unit_t time_unit
204 = static_cast<time_unit_t
>(settings_
.timeUnit() + 1);
205 output_env_init(&oenv_
, getProgramContext(), time_unit
, FALSE
, exvgNONE
, 0);
207 int frflags
= settings_
.frflags();
208 frflags
|= TRX_NEED_X
;
214 if (!read_first_frame(oenv_
, &status_
, trjfile_
.c_str(), fr
, frflags
))
216 GMX_THROW(FileIOError("Could not read coordinates from trajectory"));
220 if (topInfo_
.hasTopology())
222 const int topologyAtomCount
= topInfo_
.topology()->atoms
.nr
;
223 if (fr
->natoms
> topologyAtomCount
)
225 const std::string message
226 = formatString("Trajectory (%d atoms) does not match topology (%d atoms)",
227 fr
->natoms
, topologyAtomCount
);
228 GMX_THROW(InconsistentInputError(message
));
234 // Prepare a frame from topology information.
235 // TODO: Initialize more of the fields.
236 if (frflags
& (TRX_NEED_V
))
238 GMX_THROW(NotImplementedError("Velocity reading from a topology not implemented"));
240 if (frflags
& (TRX_NEED_F
))
242 GMX_THROW(InvalidInputError("Forces cannot be read from a topology"));
244 fr
->natoms
= topInfo_
.topology()->atoms
.nr
;
246 snew(fr
->x
, fr
->natoms
);
247 memcpy(fr
->x
, topInfo_
.xtop_
,
248 sizeof(*fr
->x
) * fr
->natoms
);
250 copy_mat(topInfo_
.boxtop_
, fr
->box
);
253 set_trxframe_ePBC(fr
, topInfo_
.ePBC());
254 if (topInfo_
.hasTopology() && settings_
.hasRmPBC())
256 gpbc_
= gmx_rmpbc_init(&topInfo_
.topology()->idef
, topInfo_
.ePBC(),
262 TrajectoryAnalysisRunnerCommon::Impl::initFrameIndexGroup()
264 if (!trajectoryGroup_
.isValid())
268 GMX_RELEASE_ASSERT(bTrajOpen_
,
269 "Trajectory index only makes sense with a real trajectory");
270 if (trajectoryGroup_
.atomCount() != fr
->natoms
)
272 const std::string message
= formatString(
273 "Selection specified with -fgroup has %d atoms, but "
274 "the trajectory (-f) has %d atoms.",
275 trajectoryGroup_
.atomCount(), fr
->natoms
);
276 GMX_THROW(InconsistentInputError(message
));
279 snew(fr
->index
, trajectoryGroup_
.atomCount());
280 std::copy(trajectoryGroup_
.atomIndices().begin(),
281 trajectoryGroup_
.atomIndices().end(),
286 TrajectoryAnalysisRunnerCommon::Impl::finishTrajectory()
295 gmx_rmpbc_done(gpbc_
);
300 /*********************************************************************
301 * TrajectoryAnalysisRunnerCommon
304 TrajectoryAnalysisRunnerCommon::TrajectoryAnalysisRunnerCommon(
305 TrajectoryAnalysisSettings
*settings
)
306 : impl_(new Impl(settings
))
311 TrajectoryAnalysisRunnerCommon::~TrajectoryAnalysisRunnerCommon()
317 TrajectoryAnalysisRunnerCommon::topologyProvider()
324 TrajectoryAnalysisRunnerCommon::initOptions(IOptionsContainer
*options
,
325 TimeUnitBehavior
*timeUnitBehavior
)
327 TrajectoryAnalysisSettings
&settings
= impl_
->settings_
;
329 // Add common file name arguments.
330 options
->addOption(FileNameOption("f")
331 .filetype(eftTrajectory
).inputFile()
332 .store(&impl_
->trjfile_
)
333 .defaultBasename("traj")
334 .description("Input trajectory or single configuration"));
335 options
->addOption(FileNameOption("s")
336 .filetype(eftTopology
).inputFile()
337 .store(&impl_
->topfile_
)
338 .defaultBasename("topol")
339 .description("Input structure"));
341 // Add options for trajectory time control.
342 options
->addOption(DoubleOption("b")
343 .store(&impl_
->startTime_
).storeIsSet(&impl_
->bStartTimeSet_
)
345 .description("First frame (%t) to read from trajectory"));
346 options
->addOption(DoubleOption("e")
347 .store(&impl_
->endTime_
).storeIsSet(&impl_
->bEndTimeSet_
)
349 .description("Last frame (%t) to read from trajectory"));
350 options
->addOption(DoubleOption("dt")
351 .store(&impl_
->deltaTime_
).storeIsSet(&impl_
->bDeltaTimeSet_
)
353 .description("Only use frame if t MOD dt == first time (%t)"));
355 // Add time unit option.
356 timeUnitBehavior
->setTimeUnitFromEnvironment();
357 timeUnitBehavior
->addTimeUnitOption(options
, "tu");
358 timeUnitBehavior
->setTimeUnitStore(&impl_
->settings_
.impl_
->timeUnit
);
360 options
->addOption(SelectionOption("fgroup")
361 .store(&impl_
->trajectoryGroup_
)
362 .onlySortedAtoms().onlyStatic()
363 .description("Atoms stored in the trajectory file "
364 "(if not set, assume first N atoms)"));
367 settings
.impl_
->plotSettings
.initOptions(options
);
369 // Add common options for trajectory processing.
370 if (!settings
.hasFlag(TrajectoryAnalysisSettings::efNoUserRmPBC
))
372 options
->addOption(BooleanOption("rmpbc").store(&settings
.impl_
->bRmPBC
)
373 .description("Make molecules whole for each frame"));
375 if (!settings
.hasFlag(TrajectoryAnalysisSettings::efNoUserPBC
))
377 options
->addOption(BooleanOption("pbc").store(&settings
.impl_
->bPBC
)
378 .description("Use periodic boundary conditions for distance calculation"));
384 TrajectoryAnalysisRunnerCommon::optionsFinished()
386 if (impl_
->trjfile_
.empty() && impl_
->topfile_
.empty())
388 GMX_THROW(InconsistentInputError("No trajectory or topology provided, nothing to do!"));
391 if (impl_
->trajectoryGroup_
.isValid() && impl_
->trjfile_
.empty())
393 GMX_THROW(InconsistentInputError("-fgroup only makes sense together with a trajectory (-f)"));
396 impl_
->settings_
.impl_
->plotSettings
.setTimeUnit(impl_
->settings_
.timeUnit());
398 if (impl_
->bStartTimeSet_
)
400 setTimeValue(TBEGIN
, impl_
->startTime_
);
402 if (impl_
->bEndTimeSet_
)
404 setTimeValue(TEND
, impl_
->endTime_
);
406 if (impl_
->bDeltaTimeSet_
)
408 setTimeValue(TDELTA
, impl_
->deltaTime_
);
414 TrajectoryAnalysisRunnerCommon::initTopology()
416 const bool topologyRequired
=
417 impl_
->settings_
.hasFlag(TrajectoryAnalysisSettings::efRequireTop
);
418 impl_
->initTopology(topologyRequired
);
423 TrajectoryAnalysisRunnerCommon::initFirstFrame()
425 impl_
->initFirstFrame();
430 TrajectoryAnalysisRunnerCommon::initFrameIndexGroup()
432 impl_
->initFrameIndexGroup();
437 TrajectoryAnalysisRunnerCommon::readNextFrame()
439 bool bContinue
= false;
442 bContinue
= read_next_frame(impl_
->oenv_
, impl_
->status_
, impl_
->fr
);
446 impl_
->finishTrajectory();
453 TrajectoryAnalysisRunnerCommon::initFrame()
455 if (impl_
->gpbc_
!= NULL
)
457 gmx_rmpbc_trxfr(impl_
->gpbc_
, impl_
->fr
);
463 TrajectoryAnalysisRunnerCommon::hasTrajectory() const
465 return impl_
->hasTrajectory();
469 const TopologyInformation
&
470 TrajectoryAnalysisRunnerCommon::topologyInformation() const
472 return impl_
->topInfo_
;
477 TrajectoryAnalysisRunnerCommon::frame() const
479 GMX_RELEASE_ASSERT(impl_
->fr
!= NULL
, "Frame not available when accessed");