Merge branch release-2018
authorMark Abraham <mark.j.abraham@gmail.com>
Thu, 4 Jan 2018 15:25:43 +0000 (16:25 +0100)
committerMark Abraham <mark.j.abraham@gmail.com>
Thu, 4 Jan 2018 15:28:08 +0000 (16:28 +0100)
Lots of copyright bumps, also

Change-Id: I0f9e8d81b265cc96cbcc84d30267932af2ab5b69

98 files changed:
CMakeLists.txt
cmake/gmxManageFFTLibraries.cmake
cmake/gmxManageGPU.cmake
scripts/xplor2gmx.pl
share/top/atom_nom.tbl
src/gromacs/commandline/pargs.cpp
src/gromacs/domdec/domdec_setup.cpp
src/gromacs/energyanalysis/tests/legacyenergy.cpp
src/gromacs/ewald/pme-gather.cpp
src/gromacs/ewald/pme-spline-work.cpp
src/gromacs/ewald/pme-spread.cpp
src/gromacs/gmxana/gmx_energy.cpp
src/gromacs/gpu_utils/gpu_utils.cu
src/gromacs/gpu_utils/gpu_utils.h
src/gromacs/gpu_utils/tests/gputest.cpp
src/gromacs/gpu_utils/tests/hostallocator.cpp
src/gromacs/gpu_utils/tests/pinnedmemorychecker.cpp
src/gromacs/hardware/architecture.h
src/gromacs/hardware/cpuinfo.cpp
src/gromacs/hardware/detecthardware.cpp
src/gromacs/listed-forces/bonded.cpp
src/gromacs/listed-forces/pairs.cpp
src/gromacs/mdlib/clincs.cpp
src/gromacs/mdlib/csettle.cpp
src/gromacs/mdlib/gmx_omp_nthreads.cpp
src/gromacs/mdlib/md_support.cpp
src/gromacs/mdlib/md_support.h
src/gromacs/mdlib/nbnxn_kernels/simd_2xnn/nbnxn_kernel_simd_2xnn_inner.h
src/gromacs/mdlib/nbnxn_kernels/simd_2xnn/nbnxn_kernel_simd_2xnn_outer.h
src/gromacs/mdlib/nbnxn_kernels/simd_4xn/nbnxn_kernel_simd_4xn_inner.h
src/gromacs/mdlib/nbnxn_kernels/simd_4xn/nbnxn_kernel_simd_4xn_outer.h
src/gromacs/mdlib/sim_util.cpp
src/gromacs/simd/impl_arm_neon/impl_arm_neon_definitions.h
src/gromacs/simd/impl_arm_neon/impl_arm_neon_util_float.h
src/gromacs/simd/impl_arm_neon_asimd/impl_arm_neon_asimd_definitions.h
src/gromacs/simd/impl_arm_neon_asimd/impl_arm_neon_asimd_util_double.h
src/gromacs/simd/impl_ibm_qpx/impl_ibm_qpx_definitions.h
src/gromacs/simd/impl_ibm_qpx/impl_ibm_qpx_simd_double.h
src/gromacs/simd/impl_ibm_qpx/impl_ibm_qpx_simd_float.h
src/gromacs/simd/impl_ibm_qpx/impl_ibm_qpx_util_double.h
src/gromacs/simd/impl_ibm_qpx/impl_ibm_qpx_util_float.h
src/gromacs/simd/impl_ibm_vmx/impl_ibm_vmx_definitions.h
src/gromacs/simd/impl_ibm_vmx/impl_ibm_vmx_util_float.h
src/gromacs/simd/impl_ibm_vsx/impl_ibm_vsx.h
src/gromacs/simd/impl_ibm_vsx/impl_ibm_vsx_definitions.h
src/gromacs/simd/impl_ibm_vsx/impl_ibm_vsx_util_double.h
src/gromacs/simd/impl_ibm_vsx/impl_ibm_vsx_util_float.h
src/gromacs/simd/impl_none/impl_none.h
src/gromacs/simd/impl_reference/impl_reference_definitions.h
src/gromacs/simd/impl_x86_avx2_128/impl_x86_avx2_128_definitions.h
src/gromacs/simd/impl_x86_avx2_256/impl_x86_avx2_256_definitions.h
src/gromacs/simd/impl_x86_avx_128_fma/impl_x86_avx_128_fma_definitions.h
src/gromacs/simd/impl_x86_avx_256/impl_x86_avx_256_definitions.h
src/gromacs/simd/impl_x86_avx_256/impl_x86_avx_256_util_double.h
src/gromacs/simd/impl_x86_avx_256/impl_x86_avx_256_util_float.h
src/gromacs/simd/impl_x86_avx_512/impl_x86_avx_512_definitions.h
src/gromacs/simd/impl_x86_avx_512/impl_x86_avx_512_util_double.h
src/gromacs/simd/impl_x86_avx_512/impl_x86_avx_512_util_float.h
src/gromacs/simd/impl_x86_avx_512_knl/impl_x86_avx_512_knl_definitions.h
src/gromacs/simd/impl_x86_mic/impl_x86_mic_definitions.h
src/gromacs/simd/impl_x86_mic/impl_x86_mic_util_double.h
src/gromacs/simd/impl_x86_mic/impl_x86_mic_util_float.h
src/gromacs/simd/impl_x86_sse2/impl_x86_sse2_definitions.h
src/gromacs/simd/impl_x86_sse2/impl_x86_sse2_util_float.h
src/gromacs/simd/impl_x86_sse4_1/impl_x86_sse4_1_definitions.h
src/gromacs/simd/simd_math.h
src/gromacs/simd/simd_memory.h
src/gromacs/simd/tests/bootstrap_loadstore.cpp
src/gromacs/simd/tests/simd.cpp
src/gromacs/simd/tests/simd.h
src/gromacs/simd/tests/simd4.cpp
src/gromacs/simd/tests/simd4_floatingpoint.cpp
src/gromacs/simd/tests/simd_floatingpoint.cpp
src/gromacs/simd/tests/simd_floatingpoint_util.cpp
src/gromacs/simd/tests/simd_integer.cpp
src/gromacs/simd/tests/simd_math.cpp
src/gromacs/simd/tests/simd_memory.cpp
src/gromacs/tables/cubicsplinetable.cpp
src/gromacs/tables/cubicsplinetable.h
src/gromacs/tables/quadraticsplinetable.cpp
src/gromacs/tables/splineutil.cpp
src/gromacs/tables/tests/splinetable.cpp
src/gromacs/taskassignment/resourcedivision.cpp
src/gromacs/taskassignment/resourcedivision.h
src/gromacs/tools/check.cpp
src/gromacs/utility/basedefinitions.h
src/gromacs/utility/coolstuff.cpp
src/gromacs/utility/tests/CMakeLists.txt
src/programs/mdrun/md.cpp
src/programs/mdrun/runner.cpp
src/programs/mdrun/tests/pmetest.cpp
src/testutils/cmdlinetest.cpp
src/testutils/cmdlinetest.h
src/testutils/testasserts.h
src/testutils/tests/testasserts_tests.cpp
tests/CMakeLists.txt
tests/CheckTarget.cmake
tests/CppCheck.cmake

index 73469b7703e21ce8d266813e7881150616603e8c..86b52f7bb2e74c18b6e740872cf516592eea21bc 100644 (file)
@@ -1,7 +1,7 @@
 #
 # This file is part of the GROMACS molecular simulation package.
 #
-# Copyright (c) 2009,2010,2011,2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
+# Copyright (c) 2009,2010,2011,2012,2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
 # Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
 # and including many others, as listed in the AUTHORS file in the
 # top-level source directory and at http://www.gromacs.org.
index 2f72efcae7ba3b0a66d01bd169c690e3aa8a56e2..f496ddd9594dfa88fcf7af8f59ba2e404cbe066a 100644 (file)
@@ -1,7 +1,7 @@
 #
 # This file is part of the GROMACS molecular simulation package.
 #
-# Copyright (c) 2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
+# Copyright (c) 2012,2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
 # Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
 # and including many others, as listed in the AUTHORS file in the
 # top-level source directory and at http://www.gromacs.org.
index 42a7a22e29824e9de7c21ab5f984511a89868102..b32df691083db65993eeeee09230966961ffce65 100644 (file)
@@ -1,7 +1,7 @@
 #
 # This file is part of the GROMACS molecular simulation package.
 #
-# Copyright (c) 2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
+# Copyright (c) 2012,2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
 # Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
 # and including many others, as listed in the AUTHORS file in the
 # top-level source directory and at http://www.gromacs.org.
index b0e28a04b1a9cb936dd1bc74a58e1e11bc327326..647459d1dec1cb9c88ee5f496c01626ee5289053 100755 (executable)
@@ -1,5 +1,6 @@
 #!/usr/bin/perl -w
 
+use strict;
 #
 # This script reads an XPLOR input file with distance restraint data
 # as sometimes is found in the pdb database (http://www.pdb.org).
 #
 
 # Turn debugging off (0), or on ( > 0).
-$debug = 1;
+my $debug = 1;
 # Turn atom name translation on and off
-$trans = 1;
+my $trans = 1;
 
-#$res0  = shift;# || die "I need the residue offset\n";
-$pdb   = shift || die "I need the name of the pdb file with correct atom numbers\n";
-$core  = shift || "core.ndx";
-$tbl   = "$ENV{GMXDATA}/top/atom_nom.tbl";
+my $pdb   = shift || die "I need the name of the pdb file with correct atom numbers\n";
+my $core  = shift || "core.ndx";
+my $tbl   = "$ENV{GMXDATA}/top/atom_nom.tbl";
 
 printf "[ distance_restraints ]\n";
 printf "; Read an xplor distance restraint file, and output GROMACS distance restraints.\n";
 printf "; This also needs a pdb file with correct GROMACS atom numbering.\n";
 printf "; I used $pdb for the atom numbers\n";
 printf "; This also needs the offset in residues.\n";
-#printf "; I used $res0 for the residue offset\n";
 
 # Read the pdb file
 # If things go wrong, check whether your pdb file is read correctly.
-$natom = 0;
-$nres  = 0;
-@resname = ();
+my $natom = 0;
+my $nres  = 0;
+my @resname;
+my @aname;
+my @resnr;
 open(PDB,$pdb) || die "Can not open file $pdb\n";
-while ($line = <PDB>) {
+while (my $line = <PDB>) {
     if (index($line,"ATOM") >= 0) {
-       @tmp = split(' ',$line);
+       my @tmp = split(' ',$line);
        $aname[$natom] = $tmp[2];
        $resnr[$natom] = $tmp[4];
        if (!defined $resname[$tmp[4]]) {
@@ -52,7 +53,7 @@ close PDB;
 printf "; I found $natom atoms in the pdb file $pdb\n";
 printf "; I found $nres residues in the pdb file $pdb\n";
 if ($debug > 1) {
-    for ($i = 0; ($i < $natom); $i ++) {
+    for (my $i = 0; ($i < $natom); $i ++) {
        printf("; %5d  %5s  %5s  %5d\n",$i+1,$aname[$i],
               $resname[$resnr[$i]],$resnr[$i]);
     }
@@ -65,10 +66,13 @@ if ($debug > 1) {
 # not for content
 #
 open(TBL,$tbl) || die "Can not open atom-name translation table $tbl\n";
-$ntbl=0;
-while ($line = <TBL>) {
-    @ttt = split('#',$line);
-    @tmp = split(' ',$ttt[0]);
+my $ntbl=0;
+my @tblxplor;
+my @tblgmx;
+my @tblres;
+while (my $line = <TBL>) {
+    my @ttt = split('#',$line);
+    my @tmp = split(' ',$ttt[0]);
     if ($#tmp == 3) {
        # New table entry
        $tblres[$ntbl] = $tmp[0];
@@ -80,34 +84,39 @@ while ($line = <TBL>) {
 close TBL;
 printf "; Read $ntbl entries from $tbl\n";
 
-@templates = (
- [ "HA#", "HA1", "HA2" ],
- [ "HA*", "HA1", "HA2" ],
- [ "HB#",  "HB",         "HB1",        "HB2"   ],
- [ "HB*",  "HB",         "HB1",        "HB2"   ],
- [ "HG#",  "HG",         "HG1",        "HG2",  "HG11", "HG12", "HG13", "HG21", "HG22", "HG23"  ],
- [ "HG*",  "HG",         "HG1",        "HG2",  "HG11", "HG12", "HG13", "HG21", "HG22", "HG23"  ],
- [ "HG1#", "HG11",     "HG12", "HG13"  ],
- [ "HG1*", "HG11",     "HG12", "HG13"  ],
- [ "HG2#", "HG21",     "HG22", "HG23"  ],
- [ "HG2*", "HG21",     "HG22", "HG23"  ],
- [ "HD#",  "HD1",      "HD2",  "HD11", "HD12", "HD13", "HD21", "HD22", "HD23" ],
- [ "HD*",  "HD1",      "HD2",  "HD11", "HD12", "HD13", "HD21", "HD22", "HD23" ],
- [ "HD1#", "HD11",     "HD12"  ],
- [ "HD1*", "HD11",     "HD12"  ],
- [ "HD2#", "HD21",     "HD22"  ],
- [ "HD2*", "HD21",     "HD22"  ],
- [ "HE#",  "HE",        "HE1", "HE2"   ],
- [ "HE*",  "HE",        "HE1", "HE2"   ],
- [ "HH#",  "HH11",     "HH12", "HH21", "HH22" ],
- [ "HH*",  "HH11",     "HH12", "HH21", "HH22" ],
- [ "HZ#",  "HZ",         "HZ1",        "HZ2",  "HZ3"   ],
- [ "HZ*",  "HZ",         "HZ1",        "HZ2",  "HZ3"   ],
- [ "HN",   "H" ]
+my $default = "XXX";
+
+my @templates = (
+ [ $default, "HA#", "HA1", "HA2" ],
+ [ $default, "HA*", "HA1", "HA2" ],
+ [ $default, "HB#",  "HB",         "HB1",      "HB2"   ],
+ [ $default, "HB*",  "HB",         "HB1",      "HB2"   ],
+ [ $default, "HG#",  "HG",         "HG1",      "HG2",  "HG11", "HG12", "HG13", "HG21", "HG22", "HG23"  ],
+ [ $default, "HG*",  "HG",         "HG1",      "HG2",  "HG11", "HG12", "HG13", "HG21", "HG22", "HG23"  ],
+ [ $default, "HG1#", "HG11",   "HG12", "HG13"  ],
+ [ $default, "HG1*", "HG11",   "HG12", "HG13"  ],
+ [ $default, "HG2#", "HG21",   "HG22", "HG23"  ],
+ [ $default, "HG2*", "HG21",   "HG22", "HG23"  ],
+ [ $default, "HD#",  "HD1",    "HD2",  "HD11", "HD12", "HD13", "HD21", "HD22", "HD23" ],
+ [ $default, "HD*",  "HD1",    "HD2",  "HD11", "HD12", "HD13", "HD21", "HD22", "HD23" ],
+ [ $default, "HD1#", "HD11",   "HD12"  ],
+ [ "ILE",    "HD1*", "HD1",    "HD2",   "HD3"  ],
+ [ $default, "HD1*", "HD11",   "HD12"  ],
+ [ $default, "HD2#", "HD21",   "HD22"  ],
+ [ $default, "HD2*", "HD21",   "HD22"  ],
+ [ $default, "HE#",  "HE",      "HE1", "HE2"   ],
+ [ "GLN",    "HE*",  "HE21",   "HE22"  ],
+ [ $default, "HE*",  "HE",        "HE1",       "HE2"   ],
+ [ $default, "HE2*", "HE2",       "HE21",      "HE22"  ],
+ [ $default, "HH#",  "HH11",   "HH12", "HH21", "HH22" ],
+ [ $default, "HH*",  "HH11",   "HH12", "HH21", "HH22" ],
+ [ $default, "HZ#",  "HZ",         "HZ1",      "HZ2",  "HZ3"   ],
+ [ $default, "HZ*",  "HZ",         "HZ1",      "HZ2",  "HZ3"   ],
+ [ $default, "HN",   "H" ]
 );
 
-$ntranslated = 0;
-$nuntransltd = 0;
+my $ntranslated = 0;
+my $nuntransltd = 0;
 sub transl_aname {
     my $resnm  = shift;
     my $atom   = shift;
@@ -124,7 +133,7 @@ sub transl_aname {
     }
     $nuntransltd++;
     if ($debug > 1) {
-       printf "; No name change for $resname[$resnr] $atom\n";
+       printf "; No name change for $resnm $atom\n";
     }
     return $atom;
 }
@@ -138,9 +147,11 @@ sub expand_template {
    
     die("No residue name for residue $rnum") if (!defined ($resname[$rnum]));
     for (my $tt=0; (($tt <= $#templates) && ($bdone == 0)); $tt++) {
-       $templ = $templates[$tt];
-       if ($atom eq $templ->[0]) {
-           for ($jj = 1; ($jj <= $#{$templ}); $jj++) {
+       my $templ = $templates[$tt];
+        if (($resname[$rnum] eq $templ->[0] ||
+             $default eq $templ->[0]) &&
+            ($atom eq $templ->[1])) {
+           for ($jj = 2; ($jj <= $#{$templ}); $jj++) {
                push @atoms, transl_aname($resname[$rnum],$templ->[$jj]);
            }
            $bdone  = 1;
@@ -152,8 +163,8 @@ sub expand_template {
     if ($debug > 0) {
        my $natom = $#atoms+1;
        printf("; Found $natom elements for atom $resname[$rnum] %d $atom:",
-              $rnum+1);
-       for $aa ( @atoms ) {
+              $rnum);
+       for my $aa ( @atoms ) {
            printf " $aa";
        }
        printf "\n";
@@ -163,82 +174,87 @@ sub expand_template {
 
 if ($debug > 1) {
     printf "; There are $#templates template entries\n";
-    for ($tt=0; ($tt <= $#templates); $tt++) {
-       $templ  = $templates[$tt];
-       $ntempl = $#{$templ};
-       printf "; Item $tt ($templates[$tt][0]) has $ntempl entries\n";
+    for (my $tt=0; ($tt <= $#templates); $tt++) {
+       my $templ  = $templates[$tt];
+        my $ntempl = $#{$templ};
+       printf "; Item $tt ($templates[$tt][0] $templates[$tt][1]) has $ntempl entries\n";
     }
 }
 
 # This index file holds numbers of restraints involving core atoms
-@protcore = ( "H", "HN", "HA", "HA1", "HA2", "HB", "HB1", "HB2", "HB3", "HG", "HG1", "HG2", "HG3", "N", "O"  );
+my @protcore = ( "H", "HN", "HA", "HA1", "HA2", "HB", "HB1", "HB2", "HB3", "HG", "HG1", "HG2", "HG3", "N", "O"  );
 open(CORE,">$core") || die "Can not open $core\n";
 print CORE "[ core-restraints ]\n";
-$ncore = 0;
+my $ncore = 0;
 
-$myindex     = 0;
-$linec       = 0;
-$npair       = 0;
-$nunresolved = 0;
-while ($line = <STDIN>) {
-    @ttt = split('!',$line);
-    if ((index($ttt[0],"assign") >= 0) && (index($ttt[0],"!assign") < 0)) {
-       @tmp = split('\(',$ttt[0]);
+my $myindex     = 0;
+my $linec       = 0;
+my $npair       = 0;
+my $nunresolved = 0;
+while (my $line = <STDIN>) {
+    my @ttt = split('!',$line);
+    if (index($ttt[0], "dihedral") >= 0) {
+        last;
+    }
+    elsif ((index($ttt[0],"assign") >= 0) && (index($ttt[0],"!assign") < 0)) {
+       my @tmp = split('\(',$ttt[0]);
        # Find first argument
+        my $rhaak = undef;
        if (($rhaak  = index($tmp[1],')')) < 0) {
            printf "No ) in '$tmp[1]'\n";
        }
-       $atres1 = substr($tmp[1],0,$rhaak);
-       @at1 = split('or',$atres1);
+       my $atres1 = substr($tmp[1],0,$rhaak);
+       my @at1 = split('or',$atres1);
        
        # Find second argument
        if (($rhaak  = index($tmp[2],')')) < 0) {
            printf "No ) in '$tmp[2]'\n";
        }
-       $atres2 = substr($tmp[2],0,$rhaak);
-       @at2 = split('or',$atres2);
+       my $atres2 = substr($tmp[2],0,$rhaak);
+       my @at2 = split('or',$atres2);
 
-       @expdata = split('\)',$tmp[2]);
-       @dist    = split(' ',$expdata[1]);
+       my @expdata = split('\)',$tmp[2]);
+       my @dist    = split(' ',$expdata[1]);
 
-       $bOK   = 0;
-       $bCore = 1;
-       foreach $a1 ( @at1 ) {
-           @info1  = split(' ',$a1);
-           $r1     = $info1[1];
-           @atoms1 = expand_template($info1[4],$r1);
+       my $bOK   = 0;
+       my $bCore = 1;
+       foreach my $a1 ( @at1 ) {
+           my @info1  = split(' ',$a1);
+           my $r1     = $info1[1];
+           my @atoms1 = expand_template($info1[4],$r1);
 
-           foreach $a2 ( @at2 ) {
-               @info2  = split(' ',$a2);
-               $r2     = $info2[1];
-               @atoms2 = expand_template($info2[4],$r2);
+           foreach my $a2 ( @at2 ) {
+               my @info2  = split(' ',$a2);
+               my $r2     = $info2[1];
+               my @atoms2 = expand_template($info2[4],$r2);
 
+                my $i = undef;
                for ($i = 0; ($i < $natom) && ($resnr[$i] < $r1); $i++) { ; }
                for ( ; ($i < $natom) && ($resnr[$i] == $r1); $i++) { 
-                   foreach $ii ( @atoms1 ) {
+                   foreach my $ii ( @atoms1 ) {
                        if ($ii eq $aname[$i]) {
-                           $bCoreI = 0;
-                           for $pp ( @protcore ) {
+                           my $bCoreI = 0;
+                           for my $pp ( @protcore ) {
                                if ($ii eq $pp) {
                                    $bCoreI = 1;
                                }
                            }
-                                       
+                            my $j = undef;
                            for ($j = 0; ($j < $natom) && ($resnr[$j] < $r2); $j++) { ; }
                            for ( ; ($j < $natom) && ($resnr[$j] == $r2); $j++) { 
-                               foreach $jj ( @atoms2 ) {
+                               foreach my $jj ( @atoms2 ) {
                                    if ($jj eq $aname[$j]) {
-                                       $dd     = 0.1*$dist[0];
-                                       $dminus = 0.1*$dist[1];
-                                       $dplus  = 0.1*$dist[2];
-                                       $low    = $dd-$dminus;
-                                       $up1    = $dd+$dplus;
-                                       $up2    = $up1+1;
+                                       my $dd     = 0.1*$dist[0];
+                                       my $dminus = 0.1*$dist[1];
+                                       my $dplus  = 0.1*$dist[2];
+                                       my $low    = $dd-$dminus;
+                                       my $up1    = $dd+$dplus;
+                                       my $up2    = $up1+1;
                                        printf("%5d %5d %5d %5d %5d %7.3f %7.3f %7.3f 1.0; res $r1 $ii - res $r2 $jj\n",$i+1,$j+1,1,$myindex,1,$low,$up1,$up2);
                                        # Do some checks
                                        $bOK    = 1;
-                                       $bCoreJ = 0;
-                                       for $pp ( @protcore ) {
+                                       my $bCoreJ = 0;
+                                       for my $pp ( @protcore ) {
                                            if ($jj eq $pp) {
                                                $bCoreJ = 1;
                                            }
index 34739164eb0da0b54d0f20c43072f925adb97fe2..0de48a24c97b70e17a0653be1d2f3067f6ef14da 100644 (file)
@@ -204,9 +204,9 @@ ILE         HG11    HG12    2HG1
 ILE            HG21    HG21    1HG2    
 ILE            HG22    HG22    2HG2    
 ILE            HG23    HG23    3HG2    
-ILE            HD11    HD11    1HD1    
-ILE            HD12    HD12    2HD1    
-ILE            HD13    HD13    3HD1    
+ILE            HD1     HD1     HD1     
+ILE            HD2     HD2     HD2     
+ILE            HD3     HD3     HD3     
 ILE            C       C       C       
 ILE            CA      CA      CA      
 ILE            CB      CB      CB      
index c0b321d7114a5539808b371b6a9c1523579f22f7..c35c3a1b35b1542b835c45890a81aa5edcf1e758 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index dfa9c1418405853a3456c53a04ac9ca7e894e01a..69956c9a8395cfb2207b528737458997a939be7f 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2008,2009,2010,2011,2012,2013,2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2008,2009,2010,2011,2012,2013,2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 7162fc1b179d3a77fc0f44419c5be00d172879de..b8a4edf43db7ec48d9daa4c3150669193cc8262e 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2017, by the GROMACS development team, led by
+ * Copyright (c) 2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index edaf535b5c8c99bdd5194d0fb4b7be60912f58f0..e9c5c0d8935697f254c46f9c8a140e33ea0bb4bb 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013,2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index cb4a625084853d7923d910030aaebeb988851e8f..37b8b07190f3a9ba31596aadd7cfe2ed9a78dfec 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013,2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index f38efc81bca8695a3cd981db65fda8c53e40e60b..3f70f80ed57be8b637a80afbce222c5b2ddd71f5 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 2a65deea16744c811b102a4aea2dacdc5f33cc16..c756e4e777b7ad14112f995c83bc86cf5d94214f 100644 (file)
@@ -1655,7 +1655,7 @@ int gmx_energy(int argc, char *argv[])
     };
     static gmx_bool    bSum    = FALSE, bFee = FALSE, bPrAll = FALSE, bFluct = FALSE, bDriftCorr = FALSE;
     static gmx_bool    bDp     = FALSE, bMutot = FALSE, bOrinst = FALSE, bOvec = FALSE, bFluctProps = FALSE;
-    static int         skip    = 0, nmol = 1, nbmin = 5, nbmax = 5;
+    static int         nmol    = 1, nbmin = 5, nbmax = 5;
     static real        reftemp = 300.0, ezero = 0;
     t_pargs            pa[]    = {
         { "-fee",   FALSE, etBOOL,  {&bFee},
@@ -1674,8 +1674,6 @@ int gmx_energy(int argc, char *argv[])
           "Maximum number of blocks for error estimate" },
         { "-mutot", FALSE, etBOOL, {&bMutot},
           "Compute the total dipole moment from the components" },
-        { "-skip", FALSE, etINT,  {&skip},
-          "Skip number of frames between data points" },
         { "-aver", FALSE, etBOOL, {&bPrAll},
           "Also print the exact average and rmsd stored in the energy frames (only when 1 term is requested)" },
         { "-nmol", FALSE, etINT,  {&nmol},
@@ -1706,7 +1704,7 @@ int gmx_energy(int argc, char *argv[])
     t_enxframe        *frame, *fr = nullptr;
     int                cur = 0;
 #define NEXT (1-cur)
-    int                nre, teller, nfr;
+    int                nre, nfr;
     gmx_int64_t        start_step;
     real               start_t;
     gmx_bool           bDHDL;
@@ -1872,7 +1870,6 @@ int gmx_energy(int argc, char *argv[])
     snew(edat.s, nset);
 
     /* Initiate counters */
-    teller       = 0;
     bFoundStart  = FALSE;
     start_step   = 0;
     start_t      = 0;
@@ -2000,69 +1997,62 @@ int gmx_energy(int argc, char *argv[])
                 time[edat.nframes] = fr->t;
                 edat.nframes++;
             }
-            /*
-             * Printing time, only when we do not want to skip frames
-             */
-            if (!skip || teller % skip == 0)
+            if (bDHDL)
             {
-                if (bDHDL)
-                {
-                    do_dhdl(fr, ir, &fp_dhdl, opt2fn("-odh", NFILE, fnm), bDp, &dh_blocks, &dh_hists, &dh_samples, &dh_lambdas, oenv);
-                }
+                do_dhdl(fr, ir, &fp_dhdl, opt2fn("-odh", NFILE, fnm), bDp, &dh_blocks, &dh_hists, &dh_samples, &dh_lambdas, oenv);
+            }
 
-                /*******************************************
-                 * E N E R G I E S
-                 *******************************************/
-                else
+            /*******************************************
+             * E N E R G I E S
+             *******************************************/
+            else
+            {
+                if (fr->nre > 0)
                 {
-                    if (fr->nre > 0)
+                    if (bPrAll)
+                    {
+                        /* We skip frames with single points (usually only the first frame),
+                         * since they would result in an average plot with outliers.
+                         */
+                        if (fr->nsum > 1)
+                        {
+                            print_time(out, fr->t);
+                            print1(out, bDp, fr->ener[set[0]].e);
+                            print1(out, bDp, fr->ener[set[0]].esum/fr->nsum);
+                            print1(out, bDp, std::sqrt(fr->ener[set[0]].eav/fr->nsum));
+                            fprintf(out, "\n");
+                        }
+                    }
+                    else
                     {
-                        if (bPrAll)
+                        print_time(out, fr->t);
+                        if (bSum)
                         {
-                            /* We skip frames with single points (usually only the first frame),
-                             * since they would result in an average plot with outliers.
-                             */
-                            if (fr->nsum > 1)
+                            sum = 0;
+                            for (i = 0; i < nset; i++)
                             {
-                                print_time(out, fr->t);
-                                print1(out, bDp, fr->ener[set[0]].e);
-                                print1(out, bDp, fr->ener[set[0]].esum/fr->nsum);
-                                print1(out, bDp, std::sqrt(fr->ener[set[0]].eav/fr->nsum));
-                                fprintf(out, "\n");
+                                sum += fr->ener[set[i]].e;
                             }
+                            print1(out, bDp, sum/nmol-ezero);
                         }
                         else
                         {
-                            print_time(out, fr->t);
-                            if (bSum)
+                            for (i = 0; (i < nset); i++)
                             {
-                                sum = 0;
-                                for (i = 0; i < nset; i++)
+                                if (bIsEner[i])
                                 {
-                                    sum += fr->ener[set[i]].e;
+                                    print1(out, bDp, (fr->ener[set[i]].e)/nmol-ezero);
                                 }
-                                print1(out, bDp, sum/nmol-ezero);
-                            }
-                            else
-                            {
-                                for (i = 0; (i < nset); i++)
+                                else
                                 {
-                                    if (bIsEner[i])
-                                    {
-                                        print1(out, bDp, (fr->ener[set[i]].e)/nmol-ezero);
-                                    }
-                                    else
-                                    {
-                                        print1(out, bDp, fr->ener[set[i]].e);
-                                    }
+                                    print1(out, bDp, fr->ener[set[i]].e);
                                 }
                             }
-                            fprintf(out, "\n");
                         }
+                        fprintf(out, "\n");
                     }
                 }
             }
-            teller++;
         }
     }
     while (bCont && (timecheck == 0));
index 9ca379ee96366cf64016c78b09fdafd5891fcad5..2df4709ab4755440375242777b30326fe470cbaa 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2010,2011,2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2010,2011,2012,2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 1a5ced2c0ba7640bebb8d1bccdd8f948edfb5367..c364363ed6efe173ec0ef518e192c61906a98ecd 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2010, The GROMACS development team.
- * Copyright (c) 2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2012,2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 03abbf8784524e8d40ff89ca87a1e6831429568f..7d7a7536a00df99ab49c0d68d36e2fc59c38a023 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2017, by the GROMACS development team, led by
+ * Copyright (c) 2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 53daa9cb980a2edc47b358416296ebfaf0877574..5ea54eaecbd25fe9c371b8150c346037e3921ef4 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2017, by the GROMACS development team, led by
+ * Copyright (c) 2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index f6d1643a9e27b86a22cbe8099a5f66d1d5dbdf35..7366aaf344eb49f5da0db49c44d1275660536648 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2017, by the GROMACS development team, led by
+ * Copyright (c) 2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index fc897a077cea4f5b6dba54c5d0edc28608f44a4a..34d5b082a18f06b30761f0bda77d3a8c2dfc653e 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2017, by the GROMACS development team, led by
+ * Copyright (c) 2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 6f16a041c52b165ef2cddfd43e975f314a1f3fbe..917bdeda609701c188842aa4f38b74b23941defe 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2012,2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index f72237eab67ebfe9328168d1a4505161528b5bb7..ea1737a5721404eb0752b44820fee5bb030f2fb6 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2012,2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 425e74478709a85abaef535ab28ece7f3ee3ea18..ac12d4c8af7eafee846c3106f2f09a254852f40d 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index dd4b061a1f0e4ff3412db11a4a6f8a350e017480..fdc2279c20983c9a7eeae6f7195316ae3c190ac5 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 6b272513ac7ca69b5b825667eaca202d77b47c80..f254bea23f98241307e4cb95a2385d27d2e30856 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index d65405c3a9942d52ca7d8b99c004b984470ec17f..0fa7e3c7221e6b2d56814b73954ac082c2221640 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 4f04591d38e7ed7e76999682b397d4afe90cb742..d8df2950446a29187303b94c54f2f16ab88c3ed8 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2012,2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 72d90484dbd69c3d0169f73a104ec29b4881fde6..b25a37cf3e95d5ebfdf5fb3a445b8b7a6f3bbb67 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index ddee3c679219a8ea3b25edd9c4d5511a46d48d56..e6b092da974e4384e2f71d782f4bbc5174fba0d3 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index ff968573b6636f9b42d54ab19238324a17446eb5..844f55d7f58ddc3860b640e30c7318ebee5bbd04 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2012,2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index b2960bce4a2a2db7874ee1a736aacc2a6d7bcdc2..ae56ddbf3be5fe52547f4e42283473c9b05f9efa 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2012,2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 782a3fbb69294ead586db6b1f302a3c9b53215c1..a3169fe83b8fc5ec30499ac758f37cca30b115d5 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2012,2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 8ca51262935a17d90fd7f24df379a8a2ce719caf..696d53a7fac0c40363c73692559199a7d119cf05 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2012,2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index ee757e41813383d99063be53eb3a16f466be1a9e..c2c40c441470b1a3cef2106b587e2dfc277878e4 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 388c44654ed016942c5f760876c5d7fc1661e080..6e767c5aaabd35a1797e5f9445bedc6680ff7cee 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 2648fef615562224fca6880ac25111d0c7025d68..93aaed2561fb24041eb3538f5ff12199da0894c4 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index c7b807d2d2fa5632979395414267559c2fbd2478..20ab5bceeabe25e8ff7479e9d209d0074121566f 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index ec54d0ee6837779d75de9a2c8b53a90b8f8394fd..2dfb2480a83aaac37faf8f5db6e22eb5df0ae0fa 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 99128004b314cca18984f2b4eafe9a56a6d8c620..a2204b0c86ee2ae389fd558c5e72d17359129a40 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 16a2f8ff343f4ecc586ec9bfcd4d4a80ff0c110e..497d45f321701f02db42db7e75452f0523f92d0e 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 83b74d1ad183bea3cca63797074801950c845d2e..322234b8f42d112214e865d429e92e4c7b441c5f 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 633327a660d35fbb643e382a6caf7d460e83ccf0..7c06ebcb3c9dd92bf2c8b5bd89daf9df8a9ea14d 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index c3b3d9cadc8833eec4a07f09a3700a00c62a3d94..e63faa92507f78833f94be1d1b25f540645ac781 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 1878d2ac70752f70a8354425c4e6b2c5dbfea42c..3400c8097751ca7e07f5437a82c8865ef11fa3ae 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index e4edc8dc34a0975c28a1e83e991ce861dbba7d45..3fc3aaa11793788034fad448e698d22e2bb091b4 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 6f49d8a9c580f6ff09216c1c3c1c86e766e9ad15..e69fd33c3999c521c4361e4488d0a1a43b18f5f3 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index b55c2a63c45f3f4a2bc912d8be76b87e31891b2e..21fb93c7c735d9c98b24bcf6be9ce2bb1352937e 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index d5745bf631e2e955dd56632976236b0208c62035..d413a5c73321fe9f883cffb1676d6756200e9eee 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index d85b0ca5ae6e2973cafdacf98f1a8956d0b6bfc0..50e8ce8ad6aa763713e9fea9e04eb4120bf50e7e 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 7688e571d5defa9052c62ac57ff5f2ac37e38c7e..d457f6d428bbcb432cce8cab752fe423ab5caee1 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index ac6f9120a49f8694cd59cfe8e7434fa5580fb856..f0f6e4e735f541801c7f966ad62b7397c5a60dc1 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 86f30dab090056d595d898714cd00e2adb3f1bc6..b44204bddc61f23b54553cea6ae1c02108579364 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index a8ab2b4f308d7404e5afbf084240c5abccd82732..da2d146cda035895730b32132ea968a9c0c3a6a9 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index ab8f533ce366e20d1f1de664775074c31ab99574..a3d53e64617bf4b71a808f42ce78821c2943974b 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 72e7ce98784055b6ea5d2361ea51970572517e1a..106ba1c3e69c010ad7b9ed543110739c76837aa9 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 23f43c988ba7250a4e44c5dca48bf196e3b117ea..241c612e12205a60aca4f6adadee61907a0a9227 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 2d19218593a1440328cb01cb852a2de73153d1b3..f96fe28ce12f964391bd9a0352af08fcda32d2f6 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index a27ea2c628b21e35626625bbb48d9be578639f5c..4e82a0fb8ff8fe8c998ad00b29a4a848997c1904 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 22b4ffaae29a1b49461a071e1a2c7cb04ee4ee10..8bb451d55064639519e87a55b48df63c0e2e62c9 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 6f94b981918492e80de572dd773eefd037283e2f..6f6bf175a419ee3cace07926f9e3238547b5124b 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index ada37e237c24fa739fbc80c0cd974c970d794d8c..6f988fed2f95df27581a7a9a0d74b5a9e746c723 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index c6135c66aba0d7e915323f83db1daeb59ebb9bbf..fc9b71990f69af824837b36ed67f7be3b0620a79 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 9904fc5fd932b8431543ffc4b00e209f7dcfd0a4..e6d6679818e952434830ec46f6314411eb624323 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 036ff2fb881edac474bb40ebdcf247f3f5365ab8..b766e1b444b5eee2936b93f7542fb3daf4ed4095 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 0cc62e9de15cb58df39e696d20064dd553a3dfa4..85128bb0dcd7ec6975cff1eb50473910482dc4f2 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 4acf483065d8480e1a86c83c51e7a0dedd50405b..53bcaffc8a8762e5716ab4bdec9bc6d89cddd94a 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index e9282ac57bfa38a2aa354e2377a407225a960a5b..0d5d3f48b95e7a6b55b9105e62ca1c594396dd1f 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 207b1b784a2d6b5c5bc9df136ea138a206aed8dc..a45ba4b84d2bb092e676c5f6c4babe00747b8108 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2012,2013,2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2012,2013,2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index aeae0cd5f940510b76408bf6aa83e778bcbba5e8..89a5d64eb7976f12b18b3283ca048aa0be80d7d5 100644 (file)
@@ -270,18 +270,6 @@ class ArrayRef<const SimdFloat> : public internal::SimdArrayRef<const SimdFloat>
     using Base = internal::SimdArrayRef<const SimdFloat>;
     using Base::Base;
 };
-template<>
-class ArrayRef<SimdFInt32> : public internal::SimdArrayRef<SimdFInt32>
-{
-    using Base = internal::SimdArrayRef<SimdFInt32>;
-    using Base::Base;
-};
-template<>
-class ArrayRef<const SimdFInt32> : public internal::SimdArrayRef<const SimdFInt32>
-{
-    using Base = internal::SimdArrayRef<const SimdFInt32>;
-    using Base::Base;
-};
 #endif
 #if GMX_SIMD_HAVE_DOUBLE
 template<>
@@ -296,18 +284,6 @@ class ArrayRef<const SimdDouble> : public internal::SimdArrayRef<const SimdDoubl
     using Base = internal::SimdArrayRef<const SimdDouble>;
     using Base::Base;
 };
-template<>
-class ArrayRef<SimdDInt32> : public internal::SimdArrayRef<SimdDInt32>
-{
-    using Base = internal::SimdArrayRef<SimdDInt32>;
-    using Base::Base;
-};
-template<>
-class ArrayRef<const SimdDInt32> : public internal::SimdArrayRef<const SimdDInt32>
-{
-    using Base = internal::SimdArrayRef<const SimdDInt32>;
-    using Base::Base;
-};
 #endif
 
 } // namespace gmx
index 1ffe38a48c8d00d327706815526ffc8247fadae9..bb9307f3c7cf80e633e1d92fd4dbcb3ef9471db6 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 3de3c0e4b3e19a124558e0ff3e792d438c6382f0..8655f64dcd5c381adc22cc040e8d91ee007a68d8 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index efa57f3589ebee1bffd16aadc828111478151869..b4d08f4c5858ec6aa6895f301428957a8da2049a 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index ba915941009e7758239c44399f772efdd785ecef..86858d67b88f765da4752d8b21536e6dc1e1014e 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 50e8687fcdb38eccc2e61a1e9f60d195131c4107..451dadd7dcc90636370a8cfe6c0eefa55c500305 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 2c57354c9bb70dcf969f173d910769422ceaa15a..825df83b6fdd07565eb5d5126a287b0681f6ae92 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index c229fb37c8696fe553e24763b219a3c8c1f62d5d..a957201707558482654eba9faa837c9bf9862b15 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 594827d84d4b943d2c44143a62f8534ac5f5e503..b2a99ecd780ab7853a74ac09aa1ac2ce9d29a7d1 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 5eddd563ab1bb2c855b299c2bc49ee63e47174db..e30c014c9d2cf0489816450208815a46b148643b 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2015,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2015,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 24aab65dbc8830bc1a4d0f345318c750edbfb724..47529122e77a0b064853e245984e5ca919a98d0e 100644 (file)
 namespace gmx
 {
 
-namespace
+#if GMX_SIMD_HAVE_REAL
+
+/* SimdInt32 is a strange type which would never belong in an interface,
+ * because its properties are peculiar to int-to-float conversions within
+ * SIMD types, so there is no need to support it as a specialization of
+ * SimdArrayRef. But it is useful here for better test coverage of
+ * SimdArrayRef. */
+
+template<>
+class ArrayRef<SimdInt32> : public internal::SimdArrayRef<SimdInt32>
 {
+    using Base = internal::SimdArrayRef<SimdInt32>;
+    using Base::Base;
+};
+template<>
+class ArrayRef<const SimdInt32> : public internal::SimdArrayRef<const SimdInt32>
+{
+    using Base = internal::SimdArrayRef<const SimdInt32>;
+    using Base::Base;
+};
 
-#if GMX_SIMD_HAVE_REAL
+namespace
+{
 
 TEST(EmptyArrayRefTest, IsEmpty)
 {
@@ -222,8 +241,8 @@ TYPED_TEST(ArrayRefArithmeticTest, Basic)
 
 #endif // GTEST_HAS_TYPED_TEST
 
-#endif // GMX_HAVE_SIMD_REAL
-
 }      // namespace
 
-}      // namespace
+#endif // GMX_HAVE_SIMD_REAL
+
+}      // namespace gmx
index 8bcb4cf06bbf3a6ceb686a84af813734bda2cb50..da94daf08cd2e61cf329938a86f5569d6158b419 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 02fbae5d69a654ddb005711423ec041f14266fe6..72e4c6399da3587e872627b21d9b2f9646ec7247 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index fe69828cf84c799a6349673ec50219dc4d053701..de4487ad985b4522026bde5c1bfe06d8c58b4c86 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index a023ec1fe111ef582221832c7e7f0bbf9b133d4e..1eb0001429c56e7ea9ffe63b49456d5097b01bac 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 203a383ea55012458f48b5637900b84c8a0acb6e..afb40706b0188f445dfa14ee923658fa80043369 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 015c8b68575771e7f078ccbcaa897aef394b21c3..497123c8b7b68dccd3a587bb3ee7fdd800842a0a 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index a2ef70feb01f002e0135e99da4d3fd556eb62363..d972c559eeb1fcb671c9de746d1b061d79086248 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 6605352eae5d2e3e5b3c41f1da8abff21b27a4ae..d7429f6a2c40228e69bdc6b0ffd073e3dbe000b7 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2013, The GROMACS development team.
- * Copyright (c) 2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index a1638ef69c5b83cde0725260d645c15e494864ff..a43a8d344665022e77fcd1863940d0581689658e 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 577e0a2de1aa75af4f86b8f6b059e7db8576b8ed..d95773c7d75298ad5416e0001a337cb1cae16db4 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
@@ -809,7 +809,8 @@ std::string getCoolQuote()
         { "A computer once beat me at chess, but it was no match for me at kick boxing.", "Emo Philips" },
         { "Home computers are being called upon to perform many new functions, including the consumption of homework formerly eaten by the dog.", "Doug Larson" },
         { "Forcefields are like dating; things go fine for a while and then sometimes it goes really bad.", "Alex MacKerell" },
-        { "This type of advanced sampling techniques... which are not so advanced, really.", "Viveca Lindahl, on AWH, at her thesis defense." }
+        { "This type of advanced sampling techniques... which are not so advanced, really.", "Viveca Lindahl, on AWH, at her thesis defense." },
+        { "C++ is tricky. You can do everything. You can even make every mistake.", "Nicolai Josuttis, CppCon2017" },
     };
 
     if (beCool())
index 74ed8f471e943a65881c5554280c535bcb83fdea..0c67bc12ea798f3ee76c1eb00121bb71b630582b 100644 (file)
@@ -1,7 +1,7 @@
 #
 # This file is part of the GROMACS molecular simulation package.
 #
-# Copyright (c) 2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
+# Copyright (c) 2012,2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
 # Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
 # and including many others, as listed in the AUTHORS file in the
 # top-level source directory and at http://www.gromacs.org.
index 683460fa6b739be9d38c88b43337780aecf4dd2b..b874903548ee2c6e40851560ea1c3c19923c72b8 100644 (file)
@@ -3,7 +3,7 @@
  *
  * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
  * Copyright (c) 2001-2004, The GROMACS development team.
- * Copyright (c) 2011,2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2011,2012,2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 05d1eb0e4ae35a414dfe0cdd78e168d64349773e..162ead1fd36131f7b80eed27a5db54021dded758 100644 (file)
@@ -444,9 +444,9 @@ int Mdrunner::mdrunner()
 
     /* CAUTION: threads may be started later on in this function, so
        cr doesn't reflect the final parallel state right now */
-    gmx::MDModules mdModules;
-    t_inputrec     inputrecInstance;
-    t_inputrec    *inputrec = &inputrecInstance;
+    std::unique_ptr<gmx::MDModules> mdModules(new gmx::MDModules);
+    t_inputrec                      inputrecInstance;
+    t_inputrec                     *inputrec = &inputrecInstance;
     snew(mtop, 1);
 
     if (mdrunOptions.continuationOptions.appendFiles)
@@ -682,7 +682,7 @@ int Mdrunner::mdrunner()
     GMX_CATCH_ALL_AND_EXIT_WITH_FATAL_ERROR;
 
     // TODO: Error handling
-    mdModules.assignOptionsToModules(*inputrec->params, nullptr);
+    mdModules->assignOptionsToModules(*inputrec->params, nullptr);
 
     if (fplog != nullptr)
     {
@@ -1143,7 +1143,7 @@ int Mdrunner::mdrunner()
     {
         /* Initiate forcerecord */
         fr                 = mk_forcerec();
-        fr->forceProviders = mdModules.initForceProviders();
+        fr->forceProviders = mdModules->initForceProviders();
         init_forcerec(fplog, mdlog, fr, fcd,
                       inputrec, mtop, cr, box,
                       opt2fn("-table", nfile, fnm),
@@ -1312,7 +1312,7 @@ int Mdrunner::mdrunner()
                                      oenv,
                                      mdrunOptions,
                                      vsite, constr,
-                                     mdModules.outputProvider(),
+                                     mdModules->outputProvider(),
                                      inputrec, mtop,
                                      fcd,
                                      globalState.get(),
@@ -1365,6 +1365,7 @@ int Mdrunner::mdrunner()
     // As soon as we destroy GPU contexts after mdrunner() exits, these lines should go.
     mdAtoms.reset(nullptr);
     globalState.reset(nullptr);
+    mdModules.reset(nullptr);   // destruct force providers here as they might also use the GPU
 
     /* Free GPU memory and set a physical node tMPI barrier (which should eventually go away) */
     free_gpu_resources(fr, cr);
index 0c11b336b6df80b25ba03c11f83ee0dd5686de46..5a8cc48b38189c0a9bc01678327b392821001580 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 2064b54c4efa65026e39593802677725c980e736..c95087a59bf0ed624b6ab27420a7029be4605644 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2012,2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 3954a321d8b0e8b10b4c560de3a4539381d14751..ccef7598d3f3fa8539c30f0057917bd4ddac29ab 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2012,2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index c7ba7a4afe7589f5c35b396082bb9a537a736ea9..93fc616d6623ea9a1a2395c0520603a927c0122f 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2013,2014,2015,2016,2017, by the GROMACS development team, led by
+ * Copyright (c) 2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index d7175eae5270ca20843a7b6a4caf428d20235f31..4089f65d2b1b740a4e2191ab70c77ef3ab26b1af 100644 (file)
@@ -1,7 +1,7 @@
 /*
  * This file is part of the GROMACS molecular simulation package.
  *
- * Copyright (c) 2014,2017, by the GROMACS development team, led by
+ * Copyright (c) 2014,2017,2018, by the GROMACS development team, led by
  * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
  * and including many others, as listed in the AUTHORS file in the
  * top-level source directory and at http://www.gromacs.org.
index 216652c8fb6dacf9df76f0a647a751443956a13a..7d0ea719bde159eaaf558d607679479ef8fb0af5 100644 (file)
@@ -1,7 +1,7 @@
 #
 # This file is part of the GROMACS molecular simulation package.
 #
-# Copyright (c) 2012,2013,2014,2015,2016,2017, by the GROMACS development team, led by
+# Copyright (c) 2012,2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
 # Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
 # and including many others, as listed in the AUTHORS file in the
 # top-level source directory and at http://www.gromacs.org.
index 5e2f00eae3b6ca81d59b96308e8da5ffb2319aed..26eef1a18be306a830bdb770a3a746dceb9d5622 100644 (file)
@@ -1,7 +1,7 @@
 #
 # This file is part of the GROMACS molecular simulation package.
 #
-# Copyright (c) 2014,2016,2017, by the GROMACS development team, led by
+# Copyright (c) 2014,2016,2017,2018, by the GROMACS development team, led by
 # Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
 # and including many others, as listed in the AUTHORS file in the
 # top-level source directory and at http://www.gromacs.org.
index 2cd46d2bbd296d3096b6fa0c3a06e4ff531701cb..9f1d658e6b0beaa9f37330c2c02589de9e597ff9 100644 (file)
@@ -1,7 +1,7 @@
 #
 # This file is part of the GROMACS molecular simulation package.
 #
-# Copyright (c) 2013,2014,2015,2016,2017, by the GROMACS development team, led by
+# Copyright (c) 2013,2014,2015,2016,2017,2018, by the GROMACS development team, led by
 # Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
 # and including many others, as listed in the AUTHORS file in the
 # top-level source directory and at http://www.gromacs.org.