Remove rest of the xml support
authorChristoph Junghans <junghans@votca.org>
Fri, 16 Nov 2012 22:06:23 +0000 (15:06 -0700)
committerChristoph Junghans <junghans@votca.org>
Fri, 16 Nov 2012 22:07:39 +0000 (15:07 -0700)
* xml_io was removed in bfab7b6030da6cec449429454e2fa9a720474838

Change-Id: If78d923f292cd5f547d88dfa07c42ec31a797c82

CMakeLists.txt
admin/gromacs.spec
src/config.h.cmakein
src/contrib/testxml.c [deleted file]
src/gmxlib/gmxfio.c
src/mdlib/CMakeLists.txt
src/mdlib/libmd.pc.cmakein

index 24b090f2a803715c09f949e8f16b758cceea344b..0d6bdd75939b13b93aefea8dab8121622a0e5e0b 100644 (file)
@@ -488,18 +488,6 @@ if(UNIX)
 endif()
 option(BUILD_SHARED_LIBS "Enable shared libraries (can be problematic with MPI, Windows)" ${SHARED_LIBS_DEFAULT})
 
-option(GMX_XML "Use libxml2 to parse xml files" ON)
-if (GMX_XML)
-  find_package(LibXml2)
-  set(PKG_XML "")
-  if(LIBXML2_FOUND)
-    include_directories(${LIBXML2_INCLUDE_DIR})
-    set(PKG_XML libxml-2.0)
-    set(XML_LIBRARIES ${LIBXML2_LIBRARIES})
-    set(HAVE_LIBXML2 1)
-  endif(LIBXML2_FOUND)
-endif(GMX_XML)
-
 option(GMX_GSL "Add support for gsl" OFF)
 if (GMX_GSL)
   find_package(gsl)
index e90d079c9d3914264f394154aeef8b1facb40586..24681975c3faa6b5482a6a15536cdb9d75ac6367 100644 (file)
@@ -21,7 +21,6 @@ Requires:     gromacs-common  = %{version}-%{release}
 
 BuildRequires: fftw-devel
 BuildRequires: gsl-devel
-BuildRequires: libxml2-devel
 BuildRequires: openmpi-devel
 
 %if 0%{?rhel} == 4
index 14cbbce89e545bcf1e4baf080ef2f28d326d6881..ba3595bd22ca3dcf6909f568c434f6aa15c79bfa 100644 (file)
 /* Define to 1 if you have the gsl library (-lgsl). */
 #cmakedefine HAVE_LIBGSL
 
-/* Define to 1 if you have the xml2 library (-lxml2). */
-#cmakedefine HAVE_LIBXML2
-
 /* Define to 1 if you have the dl library (-ldl). */
 #cmakedefine HAVE_LIBDL
 
diff --git a/src/contrib/testxml.c b/src/contrib/testxml.c
deleted file mode 100644 (file)
index bea44f4..0000000
+++ /dev/null
@@ -1,79 +0,0 @@
-/*
- * 
- *                This source code is part of
- * 
- *                 G   R   O   M   A   C   S
- * 
- *          GROningen MAchine for Chemical Simulations
- * 
- *                        VERSION 3.2.0
- * Written by David van der Spoel, Erik Lindahl, Berk Hess, and others.
- * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
- * Copyright (c) 2001-2004, The GROMACS development team,
- * check out http://www.gromacs.org for more information.
-
- * This program is free software; you can redistribute it and/or
- * modify it under the terms of the GNU General Public License
- * as published by the Free Software Foundation; either version 2
- * of the License, or (at your option) any later version.
- * 
- * If you want to redistribute modifications, please consider that
- * scientific software is very special. Version control is crucial -
- * bugs must be traceable. We will be happy to consider code for
- * inclusion in the official distribution, but derived work must not
- * be called official GROMACS. Details are found in the README & COPYING
- * files - if they are missing, get the official version at www.gromacs.org.
- * 
- * To help us fund GROMACS development, we humbly ask that you cite
- * the papers on the package - you can find them in the top README file.
- * 
- * For more info, check our website at http://www.gromacs.org
- * 
- * And Hey:
- * GROningen Mixture of Alchemy and Childrens' Stories
- */
-#include "macros.h"
-#include "smalloc.h"
-#include "xmlio.h"
-#include "statutil.h"
-#include "tpxio.h"
-
-int main(int argc,char *argv[])
-{
-  int        step,natoms;
-  real       t,lambda;
-  t_inputrec ir;
-  t_topology top;
-  matrix     box;
-  rvec       *x,*v,*f;
-  t_filenm fnm[] = {
-    { efTPX, NULL, NULL, ffREAD  },
-    { efXML, "-r", NULL, ffREAD  },
-    { efXML, "-o", NULL, ffWRITE }
-  };  
-#define NFILE asize(fnm)
-
-  CopyRight(stderr,argv[0]);
-  parse_common_args(&argc,argv,0,NFILE,fnm,0,NULL,0,NULL,0,NULL);
-  
-  init_top(&top);
-  if (opt2bSet("-r",NFILE,fnm))
-    read_xml(opt2fn("-r",NFILE,fnm),&step,&t,&lambda,&ir,
-            box,&natoms,&x,&v,&f,&top);
-  else {
-    t_tpxheader tpx;
-    
-    read_tpxheader(ftp2fn(efTPX,NFILE,fnm),&tpx,FALSE);
-    snew(x,tpx.natoms);
-    snew(v,tpx.natoms);
-    f = NULL;
-    read_tpx(ftp2fn(efTPX,NFILE,fnm),&step,&t,&lambda,&ir,
-            box,&natoms,x,v,f,&top);
-  }
-  /*write_xml(opt2fn("-o",NFILE,fnm),step,t,lambda,&ir,box,natoms,x,v,f,&top);*/
-  
-  return 0;
-}
-
-
-
index d693ae20b67d72add62695cd0481e11c0e0b4c38..0be756d5043c435b6f0c2c2c504e0b4362d8212a 100644 (file)
@@ -89,10 +89,6 @@ static const int ftpASC[] =
     { efTPA, efGRO, efPDB };
 static const int ftpBIN[] =
     { efTPB, efTRJ };
-#ifdef HAVE_XML
-static const int ftpXML[] =
-    {   efXML};
-#endif
 
 const char *itemstr[eitemNR] =
     { "[header]", "[inputrec]", "[box]", "[topology]", "[coordinates]",
@@ -233,12 +229,6 @@ static void gmx_fio_set_iotype(t_fileio *fio)
     {
         fio->iotp=&bin_iotype;
     }
-#ifdef HAVE_XMl
-    else if (in_ftpset(fio->iFTP,asize(ftpXML),ftpXML))
-    {
-        fio->iotp=&dummy_iotype;
-    }
-#endif
     else
         fio->iotp=&dummy_iotype;
 }
@@ -909,12 +899,6 @@ void gmx_fio_checktype(t_fileio *fio)
     {
         return;
     }
-#ifdef HAVE_XMl
-    else if (in_ftpset(fio->iFTP,asize(ftpXML),ftpXML))
-    {
-        return;
-    }
-#endif
     else
         gmx_fatal(FARGS, "Can not read/write topologies to file type %s",
                   ftp2ext(fio->iFTP));
index bb4f80aaeb8453a76260993e4caa912dd6509e66..55dd97ec9d708fb1bbef6f4add7e7f9b12ebd722 100644 (file)
@@ -22,7 +22,7 @@ endif()
 
 add_library(md ${MDLIB_SOURCES})
 
-target_link_libraries(md ${GMX_GPU_LIBRARIES} gmx ${GMX_EXTRA_LIBRARIES} ${FFT_LIBRARIES} ${XML_LIBRARIES} ${OpenMP_SHARED_LINKER_FLAGS})
+target_link_libraries(md ${GMX_GPU_LIBRARIES} gmx ${GMX_EXTRA_LIBRARIES} ${FFT_LIBRARIES} ${OpenMP_SHARED_LINKER_FLAGS})
 
 set_target_properties(md PROPERTIES OUTPUT_NAME "md${GMX_LIBS_SUFFIX}" SOVERSION ${SOVERSION} INSTALL_NAME_DIR "${LIB_INSTALL_DIR}"
     COMPILE_FLAGS "${OpenMP_C_FLAGS}")
index 0006b967549f09b306a385f4b3cfa3f8f7ff4801..d93a4c2b9ba5b3a43dd5da66361d629759fdb291 100644 (file)
@@ -5,7 +5,7 @@ Name: libmd
 Description: Gromacs md lib
 URL: http://www.gromacs.org
 Version: @PROJECT_VERSION@
-Requires: libgmx@GMX_LIBS_SUFFIX@ @PKG_FFT@ @PKG_XML@
+Requires: libgmx@GMX_LIBS_SUFFIX@ @PKG_FFT@
 Libs.private: -lm @CMAKE_THREAD_LIBS_INIT@
 Libs: -L${libdir} -lmd@GMX_LIBS_SUFFIX@ @PKG_FFT_LIBS@
 Cflags: -I${includedir} @PKG_CFLAGS@