aboutsummaryrefslogtreecommitdiffhomepage
path: root/bench/btl/libs/f77
diff options
context:
space:
mode:
authorGravatar Gael Guennebaud <g.gael@free.fr>2011-03-23 10:07:24 +0100
committerGravatar Gael Guennebaud <g.gael@free.fr>2011-03-23 10:07:24 +0100
commite35b1ef3f39bac2fc4391a8326b50602425fb588 (patch)
treef7598761a1506ea8be009532a3dc92b1bc676611 /bench/btl/libs/f77
parentfe595e91ae9a2d8544cae167775d7a076fcaf27c (diff)
BTL: rm stupid backends
Diffstat (limited to 'bench/btl/libs/f77')
-rw-r--r--bench/btl/libs/f77/CMakeLists.txt6
-rw-r--r--bench/btl/libs/f77/daat.f14
-rw-r--r--bench/btl/libs/f77/data.f14
-rw-r--r--bench/btl/libs/f77/daxpy.f18
-rw-r--r--bench/btl/libs/f77/dmxm.f32
-rw-r--r--bench/btl/libs/f77/dmxm.f.mfr36
-rw-r--r--bench/btl/libs/f77/dmxv.f39
-rw-r--r--bench/btl/libs/f77/f77_interface.hh129
-rw-r--r--bench/btl/libs/f77/f77_interface_base.hh91
-rw-r--r--bench/btl/libs/f77/main.cpp47
-rw-r--r--bench/btl/libs/f77/saat.f14
-rw-r--r--bench/btl/libs/f77/sata.f14
-rw-r--r--bench/btl/libs/f77/saxpy.f16
-rw-r--r--bench/btl/libs/f77/smxm.f32
-rw-r--r--bench/btl/libs/f77/smxv.f38
-rw-r--r--bench/btl/libs/f77/test_interface.hh36
16 files changed, 0 insertions, 576 deletions
diff --git a/bench/btl/libs/f77/CMakeLists.txt b/bench/btl/libs/f77/CMakeLists.txt
deleted file mode 100644
index cecb9160c..000000000
--- a/bench/btl/libs/f77/CMakeLists.txt
+++ /dev/null
@@ -1,6 +0,0 @@
-if(CMAKE_MINOR_VERSION GREATER 4)
- if(NOT MSVC)
- enable_language(Fortran)
- endif(NOT MSVC)
- btl_add_bench(btl_f77 main.cpp dmxv.f smxv.f dmxm.f smxm.f daxpy.f saxpy.f data.f sata.f daat.f saat.f OFF)
-endif(CMAKE_MINOR_VERSION GREATER 4) \ No newline at end of file
diff --git a/bench/btl/libs/f77/daat.f b/bench/btl/libs/f77/daat.f
deleted file mode 100644
index a50329a66..000000000
--- a/bench/btl/libs/f77/daat.f
+++ /dev/null
@@ -1,14 +0,0 @@
- SUBROUTINE DAAT(A,X,N)
-**
-** X = AT * A
- REAL*8 A(N,N),X(N,N),R
- DO 20 I=1,N
- DO 20 J=1,N
- R=0.
- DO 10 K=1,N
- R=R+A(I,K)*A(J,K)
- 10 CONTINUE
- X(I,J)=R
- 20 CONTINUE
- RETURN
- END
diff --git a/bench/btl/libs/f77/data.f b/bench/btl/libs/f77/data.f
deleted file mode 100644
index 709211ca5..000000000
--- a/bench/btl/libs/f77/data.f
+++ /dev/null
@@ -1,14 +0,0 @@
- SUBROUTINE DATA(A,X,N)
-**
-** X = AT * A
- REAL*8 A(N,N),X(N,N),R
- DO 20 I=1,N
- DO 20 J=1,N
- R=0.
- DO 10 K=1,N
- R=R+A(K,I)*A(K,J)
- 10 CONTINUE
- X(I,J)=R
- 20 CONTINUE
- RETURN
- END
diff --git a/bench/btl/libs/f77/daxpy.f b/bench/btl/libs/f77/daxpy.f
deleted file mode 100644
index 29514a222..000000000
--- a/bench/btl/libs/f77/daxpy.f
+++ /dev/null
@@ -1,18 +0,0 @@
- SUBROUTINE DAXPYF(N,A,X,Y)
-** ***************************************
-** CALCULE Y = Y + A*X
-** ***************************************
-*>N NOMBRE D'OPERATIONS A FAIRE
-*>A CONSTANTE MULTIPLICATIVE
-*>X TABLEAU
-*=Y TABLEAU DES RESULTATS
-*A R. SANCHEZ ( EARLY WINTER 1987 )
-*V M.F. ROBEAU
- REAL*8 X(1),Y(1)
- REAL*8 A
- DO 10 I=1,N
- Y(I)=Y(I)+A*X(I)
- 10 CONTINUE
- RETURN
- END
-
diff --git a/bench/btl/libs/f77/dmxm.f b/bench/btl/libs/f77/dmxm.f
deleted file mode 100644
index eb7ef9006..000000000
--- a/bench/btl/libs/f77/dmxm.f
+++ /dev/null
@@ -1,32 +0,0 @@
- SUBROUTINE DMXM(A,N,B,M,C,L)
-**
-** C = A * B
-** A ET B MATRICES A(N,M) B(M,L) ==> C(N,L)
-**
-*>A PREMIERE MATRICE
-*>N PREMIERE DIMENSION DE A ET DE C
-*>B DEUXIEME MATRICE
-*>M DEUXIEME DIMENSION DE A ET PERMIERE DE B
-*<C MATRICE PRODUIT DE A ET DE B
-*>L DEUXIEME DIMENSION DE B ET DE C
-*A R. SANCHEZ ( EARLY WINTER 1987 )
-*V M.F. ROBEAU
-*M AM BAUDRON - AVRIL 94
-*: ERREUR DANS L'APPEL A L'UTILITAIRE SGEMM
-*: APPEL A L'UTILITAIRE SGEMM DE LA LIBRAIRIE BLAS SUR HP
-*M AM BAUDRON - NOVEMBRE 1991
-*: ERREUR ( SOMME SUR LES TERMES PAS FAITE )
-*: APPEL A L'UTILITAIRE SGEMM DE LA LIBRAIRIE BLAS SUR RISC
-*M AM BAUDRON - MAI 1993
-*: CHANGEMENT DES %IF LOCAL SUN MIPS SUITE A INTRODUCTION VERSION IBM
- REAL*8 A(N,M),B(M,L),C(N,L),R
- DO 20 I=1,N
- DO 20 J=1,L
- R=0.
- DO 10 K=1,M
- R=R+A(I,K)*B(K,J)
- 10 CONTINUE
- C(I,J)=R
- 20 CONTINUE
- RETURN
- END
diff --git a/bench/btl/libs/f77/dmxm.f.mfr b/bench/btl/libs/f77/dmxm.f.mfr
deleted file mode 100644
index 82ccac9a5..000000000
--- a/bench/btl/libs/f77/dmxm.f.mfr
+++ /dev/null
@@ -1,36 +0,0 @@
-
- SUBROUTINE DMXM(A,N,B,M,C,L)
-**
-** C = A * B
-** A ET B MATRICES A(N,M) B(M,L) ==> C(N,L)
-**
-*>A PREMIERE MATRICE
-*>N PREMIERE DIMENSION DE A ET DE C
-*>B DEUXIEME MATRICE
-*>M DEUXIEME DIMENSION DE A ET PERMIERE DE B
-*<C MATRICE PRODUIT DE A ET DE B
-*>L DEUXIEME DIMENSION DE B ET DE C
-*A R. SANCHEZ ( EARLY WINTER 1987 )
-*V M.F. ROBEAU
-*M AM BAUDRON - AVRIL 94
-*: ERREUR DANS L'APPEL A L'UTILITAIRE SGEMM
-*: APPEL A L'UTILITAIRE SGEMM DE LA LIBRAIRIE BLAS SUR HP
-*M AM BAUDRON - NOVEMBRE 1991
-*: ERREUR ( SOMME SUR LES TERMES PAS FAITE )
-*: APPEL A L'UTILITAIRE SGEMM DE LA LIBRAIRIE BLAS SUR RISC
-*M AM BAUDRON - MAI 1993
-*: CHANGEMENT DES %IF LOCAL SUN MIPS SUITE A INTRODUCTION VERSION IBM
- REAL*8 A(N,M),B(M,L),C(N,L),R
- DO 5 J=1,L
- DO 5 I=1,N
- C(I,J)=0.
- 5 CONTINUE
- DO 10 K=1,M
- DO 20 J=1,L
- R=B(K,J)
- DO 20 I=1,N
- C(I,J)=C(I,J)+A(I,K)*R
- 20 CONTINUE
- 10 CONTINUE
- RETURN
- END
diff --git a/bench/btl/libs/f77/dmxv.f b/bench/btl/libs/f77/dmxv.f
deleted file mode 100644
index bd7e4d550..000000000
--- a/bench/btl/libs/f77/dmxv.f
+++ /dev/null
@@ -1,39 +0,0 @@
- SUBROUTINE DMXV(A,N,X,M,R)
-C
-**
-** VERSION DOUBLE PRECISION DE MXV
-** R = A * X
-** A MATRICE A(N,M)
-** R ET X VECTEURS
-**
-*>A PREMIERE MATRICE
-*>N PREMIERE DIMENSION DE A
-*>X VECTEUR
-*>M DEUXIEME DIMENSION DE A
-*<R VECTEUR PRODUIT DE A ET DE X
-**
-*A M. COSTE
-*V M.F. ROBEAU
-*M
-*
- REAL*8 X(1),R(1),A(N,M)
- REAL*8 S
-C DO 20 I=1,N
-C S=0.
-C DO 10 J=1,M
-C S=S+A(I,J)*X(J)
-C 10 CONTINUE
-C R(I)=S
-C 20 CONTINUE
- DO 5 I=1,N
- R(I)=0
- 5 CONTINUE
- DO 10 J=1,M
- S=X(J)
- DO 20 I=1,N
- R(I)=R(I)+A(I,J)*S
- 20 CONTINUE
- 10 CONTINUE
- RETURN
- END
-
diff --git a/bench/btl/libs/f77/f77_interface.hh b/bench/btl/libs/f77/f77_interface.hh
deleted file mode 100644
index 8267dbd42..000000000
--- a/bench/btl/libs/f77/f77_interface.hh
+++ /dev/null
@@ -1,129 +0,0 @@
-//=====================================================
-// File : f77_interface.hh
-// Author : L. Plagne <laurent.plagne@edf.fr)>
-// Copyright (C) EDF R&D, lun sep 30 14:23:24 CEST 2002
-//=====================================================
-//
-// 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.
-//
-// This program is distributed in the hope that it will be useful,
-// but WITHOUT ANY WARRANTY; without even the implied warranty of
-// MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
-// GNU General Public License for more details.
-// You should have received a copy of the GNU General Public License
-// along with this program; if not, write to the Free Software
-// Foundation, Inc., 59 Temple Place - Suite 330, Boston, MA 02111-1307, USA.
-//
-#ifndef F77_INTERFACE_HH
-#define F77_INTERFACE_HH
-#include "f77_interface_base.hh"
-#include <string>
-
-extern "C"
-{
- void dmxv_(double * A, int * N, double * X, int * M, double *R);
- void smxv_(float * A, int * N, float * X, int * M, float *R);
-
- void dmxm_(double * A, int * N, double * B, int * M, double *C, int * K);
- void smxm_(float * A, int * N, float * B, int * M, float *C, int * K);
-
- void data_(double * A, double *X, int * N);
- void sata_(float * A, float *X, int * N);
-
- void daat_(double * A, double *X, int * N);
- void saat_(float * A, float *X, int * N);
-
- void saxpyf_(int * N, float * coef, float * X, float *Y);
- void daxpyf_(int * N, double * coef, double * X, double *Y);
-}
-
-template<class real>
-class f77_interface : public f77_interface_base<real>
-{
-public :
-
- typedef typename f77_interface_base<real>::gene_matrix gene_matrix;
- typedef typename f77_interface_base<real>::gene_vector gene_vector;
-
- static inline std::string name( void )
- {
- return "f77";
- }
-
- static inline void matrix_vector_product(gene_matrix & A, gene_vector & B, gene_vector & X, int N)
- {
- dmxv_(A,&N,B,&N,X);
- }
-
- static inline void matrix_matrix_product(gene_matrix & A, gene_matrix & B, gene_matrix & X, int N)
- {
- dmxm_(A,&N,B,&N,X,&N);
- }
-
- static inline void ata_product(gene_matrix & A, gene_matrix & X, int N)
- {
- data_(A,X,&N);
- }
-
- static inline void aat_product(gene_matrix & A, gene_matrix & X, int N)
- {
- daat_(A,X,&N);
- }
-
- static inline void axpy(real coef, const gene_vector & X, gene_vector & Y, int N)
- {
- int one=1;
- daxpyf_(&N,&coef,X,Y);
- }
-
-
-};
-
-
-template<>
-class f77_interface<float> : public f77_interface_base<float>
-{
-public :
-
- static inline std::string name( void )
- {
- return "F77";
- }
-
-
- static inline void matrix_vector_product(gene_matrix & A, gene_vector & B, gene_vector & X, int N)
- {
- smxv_(A,&N,B,&N,X);
- }
-
- static inline void matrix_matrix_product(gene_matrix & A, gene_matrix & B, gene_matrix & X, int N)
- {
- smxm_(A,&N,B,&N,X,&N);
- }
-
- static inline void ata_product(gene_matrix & A, gene_matrix & X, int N)
- {
- sata_(A,X,&N);
- }
-
- static inline void aat_product(gene_matrix & A, gene_matrix & X, int N)
- {
- saat_(A,X,&N);
- }
-
-
- static inline void axpy(float coef, const gene_vector & X, gene_vector & Y, int N)
- {
- saxpyf_(&N,&coef,X,Y);
- }
-
-};
-
-
-#endif
-
-
-
diff --git a/bench/btl/libs/f77/f77_interface_base.hh b/bench/btl/libs/f77/f77_interface_base.hh
deleted file mode 100644
index ab8a18295..000000000
--- a/bench/btl/libs/f77/f77_interface_base.hh
+++ /dev/null
@@ -1,91 +0,0 @@
-//=====================================================
-// File : f77_interface_base.hh
-// Author : L. Plagne <laurent.plagne@edf.fr)>
-// Copyright (C) EDF R&D, lun sep 30 14:23:25 CEST 2002
-//=====================================================
-//
-// 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.
-//
-// This program is distributed in the hope that it will be useful,
-// but WITHOUT ANY WARRANTY; without even the implied warranty of
-// MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
-// GNU General Public License for more details.
-// You should have received a copy of the GNU General Public License
-// along with this program; if not, write to the Free Software
-// Foundation, Inc., 59 Temple Place - Suite 330, Boston, MA 02111-1307, USA.
-//
-#ifndef F77_INTERFACE_BASE_HH
-#define F77_INTERFACE_BASE_HH
-
-#include "utilities.h"
-#include <vector>
-template<class real>
-class f77_interface_base{
-
-public:
-
- typedef real real_type ;
- typedef std::vector<real> stl_vector;
- typedef std::vector<stl_vector > stl_matrix;
-
- typedef real * gene_matrix;
- typedef real * gene_vector;
-
- static void free_matrix(gene_matrix & A, int N){
- delete A;
- }
-
- static void free_vector(gene_vector & B){
- delete B;
- }
-
- static inline void matrix_from_stl(gene_matrix & A, stl_matrix & A_stl){
- int N = A_stl.size();
- A = new real[N*N];
- for (int j=0;j<N;j++)
- for (int i=0;i<N;i++)
- A[i+N*j] = A_stl[j][i];
- }
-
- static inline void vector_from_stl(gene_vector & B, stl_vector & B_stl){
- int N = B_stl.size();
- B = new real[N];
- for (int i=0;i<N;i++)
- B[i] = B_stl[i];
- }
-
- static inline void vector_to_stl(gene_vector & B, stl_vector & B_stl){
- int N = B_stl.size();
- for (int i=0;i<N;i++)
- B_stl[i] = B[i];
- }
-
- static inline void matrix_to_stl(gene_matrix & A, stl_matrix & A_stl){
- int N = A_stl.size();
- for (int j=0;j<N;j++){
- A_stl[j].resize(N);
- for (int i=0;i<N;i++)
- A_stl[j][i] = A[i+N*j];
- }
- }
-
- static inline void copy_vector(const gene_vector & source, gene_vector & cible, int N){
- for (int i=0;i<N;i++)
- cible[i]=source[i];
- }
-
- static inline void copy_matrix(const gene_matrix & source, gene_matrix & cible, int N){
- for (int j=0;j<N;j++){
- for (int i=0;i<N;i++){
- cible[i+N*j] = source[i+N*j];
- }
- }
- }
-
-};
-
-
-#endif
diff --git a/bench/btl/libs/f77/main.cpp b/bench/btl/libs/f77/main.cpp
deleted file mode 100644
index a4b67b487..000000000
--- a/bench/btl/libs/f77/main.cpp
+++ /dev/null
@@ -1,47 +0,0 @@
-//=====================================================
-// File : main.cpp
-// Author : L. Plagne <laurent.plagne@edf.fr)>
-// Copyright (C) EDF R&D, lun sep 30 14:23:25 CEST 2002
-//=====================================================
-//
-// 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.
-//
-// This program is distributed in the hope that it will be useful,
-// but WITHOUT ANY WARRANTY; without even the implied warranty of
-// MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
-// GNU General Public License for more details.
-// You should have received a copy of the GNU General Public License
-// along with this program; if not, write to the Free Software
-// Foundation, Inc., 59 Temple Place - Suite 330, Boston, MA 02111-1307, USA.
-//
-#include "utilities.h"
-#include "f77_interface.hh"
-#include "bench.hh"
-#include "action_matrix_vector_product.hh"
-#include "action_matrix_matrix_product.hh"
-#include "action_axpy.hh"
-#include "action_lu_solve.hh"
-#include "action_ata_product.hh"
-#include "action_aat_product.hh"
-
-BTL_MAIN;
-
-int main()
-{
- bench<Action_axpy<f77_interface<REAL_TYPE> > >(MIN_AXPY,MAX_AXPY,NB_POINT);
-
- bench<Action_matrix_vector_product<f77_interface<REAL_TYPE> > >(MIN_MV,MAX_MV,NB_POINT);
-
- bench<Action_matrix_matrix_product<f77_interface<REAL_TYPE> > >(MIN_MM,MAX_MM,NB_POINT);
-
- bench<Action_ata_product<f77_interface<REAL_TYPE> > >(MIN_MM,MAX_MM,NB_POINT);
-
- bench<Action_aat_product<f77_interface<REAL_TYPE> > >(MIN_MM,MAX_MM,NB_POINT);
-
- return 0;
-}
-
-
diff --git a/bench/btl/libs/f77/saat.f b/bench/btl/libs/f77/saat.f
deleted file mode 100644
index 5d1855d2c..000000000
--- a/bench/btl/libs/f77/saat.f
+++ /dev/null
@@ -1,14 +0,0 @@
- SUBROUTINE SAAT(A,X,N)
-**
-** X = AT * A
- REAL*4 A(N,N),X(N,N)
- DO 20 I=1,N
- DO 20 J=1,N
- R=0.
- DO 10 K=1,N
- R=R+A(I,K)*A(J,K)
- 10 CONTINUE
- X(I,J)=R
- 20 CONTINUE
- RETURN
- END
diff --git a/bench/btl/libs/f77/sata.f b/bench/btl/libs/f77/sata.f
deleted file mode 100644
index 3ab83d958..000000000
--- a/bench/btl/libs/f77/sata.f
+++ /dev/null
@@ -1,14 +0,0 @@
- SUBROUTINE SATA(A,X,N)
-**
-** X = AT * A
- REAL*4 A(N,N),X(N,N)
- DO 20 I=1,N
- DO 20 J=1,N
- R=0.
- DO 10 K=1,N
- R=R+A(K,I)*A(K,J)
- 10 CONTINUE
- X(I,J)=R
- 20 CONTINUE
- RETURN
- END
diff --git a/bench/btl/libs/f77/saxpy.f b/bench/btl/libs/f77/saxpy.f
deleted file mode 100644
index d0f74fd70..000000000
--- a/bench/btl/libs/f77/saxpy.f
+++ /dev/null
@@ -1,16 +0,0 @@
- SUBROUTINE SAXPYF(N,A,X,Y)
-** ***************************************
-** CALCULE Y = Y + A*X
-** ***************************************
-*>N NOMBRE D'OPERATIONS A FAIRE
-*>A CONSTANTE MULTIPLICATIVE
-*>X TABLEAU
-*=Y TABLEAU DES RESULTATS
-*A R. SANCHEZ ( EARLY WINTER 1987 )
-*V M.F. ROBEAU
- DIMENSION X(1),Y(1)
- DO 10 I=1,N
- Y(I)=Y(I)+A*X(I)
- 10 CONTINUE
- RETURN
- END
diff --git a/bench/btl/libs/f77/smxm.f b/bench/btl/libs/f77/smxm.f
deleted file mode 100644
index a1e63adca..000000000
--- a/bench/btl/libs/f77/smxm.f
+++ /dev/null
@@ -1,32 +0,0 @@
- SUBROUTINE SMXM(A,N,B,M,C,L)
-**
-** C = A * B
-** A ET B MATRICES A(N,M) B(M,L) ==> C(N,L)
-**
-*>A PREMIERE MATRICE
-*>N PREMIERE DIMENSION DE A ET DE C
-*>B DEUXIEME MATRICE
-*>M DEUXIEME DIMENSION DE A ET PERMIERE DE B
-*<C MATRICE PRODUIT DE A ET DE B
-*>L DEUXIEME DIMENSION DE B ET DE C
-*A R. SANCHEZ ( EARLY WINTER 1987 )
-*V M.F. ROBEAU
-*M AM BAUDRON - AVRIL 94
-*: ERREUR DANS L'APPEL A L'UTILITAIRE SGEMM
-*: APPEL A L'UTILITAIRE SGEMM DE LA LIBRAIRIE BLAS SUR HP
-*M AM BAUDRON - NOVEMBRE 1991
-*: ERREUR ( SOMME SUR LES TERMES PAS FAITE )
-*: APPEL A L'UTILITAIRE SGEMM DE LA LIBRAIRIE BLAS SUR RISC
-*M AM BAUDRON - MAI 1993
-*: CHANGEMENT DES %IF LOCAL SUN MIPS SUITE A INTRODUCTION VERSION IBM
- DIMENSION A(N,M),B(M,L),C(N,L)
- DO 20 I=1,N
- DO 20 J=1,L
- R=0.
- DO 10 K=1,M
- R=R+A(I,K)*B(K,J)
- 10 CONTINUE
- C(I,J)=R
- 20 CONTINUE
- RETURN
- END
diff --git a/bench/btl/libs/f77/smxv.f b/bench/btl/libs/f77/smxv.f
deleted file mode 100644
index d2f7ed24e..000000000
--- a/bench/btl/libs/f77/smxv.f
+++ /dev/null
@@ -1,38 +0,0 @@
- SUBROUTINE SMXV(A,N,X,M,R)
-C
-**
-** VERSION DOUBLE PRECISION DE MXV
-** R = A * X
-** A MATRICE A(N,M)
-** R ET X VECTEURS
-**
-*>A PREMIERE MATRICE
-*>N PREMIERE DIMENSION DE A
-*>X VECTEUR
-*>M DEUXIEME DIMENSION DE A
-*<R VECTEUR PRODUIT DE A ET DE X
-**
-*A M. COSTE
-*V M.F. ROBEAU
-*M
-*
- REAL*4 X(1),R(1),A(N,M)
- REAL*4 S
-C DO 20 I=1,N
-C S=0.
-C DO 10 J=1,M
-C S=S+A(I,J)*X(J)
-C 10 CONTINUE
-C R(I)=S
-C 20 CONTINUE
- DO 5 I=1,N
- R(I)=0
- 5 CONTINUE
- DO 10 J=1,M
- S=X(J)
- DO 20 I=1,N
- R(I)=R(I)+A(I,J)*S
- 20 CONTINUE
- 10 CONTINUE
- RETURN
- END
diff --git a/bench/btl/libs/f77/test_interface.hh b/bench/btl/libs/f77/test_interface.hh
deleted file mode 100644
index 230c8dbc8..000000000
--- a/bench/btl/libs/f77/test_interface.hh
+++ /dev/null
@@ -1,36 +0,0 @@
-//=====================================================
-// File : test_interface.hh
-// Author : L. Plagne <laurent.plagne@edf.fr)>
-// Copyright (C) EDF R&D, lun sep 30 14:23:25 CEST 2002
-//=====================================================
-//
-// 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.
-//
-// This program is distributed in the hope that it will be useful,
-// but WITHOUT ANY WARRANTY; without even the implied warranty of
-// MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
-// GNU General Public License for more details.
-// You should have received a copy of the GNU General Public License
-// along with this program; if not, write to the Free Software
-// Foundation, Inc., 59 Temple Place - Suite 330, Boston, MA 02111-1307, USA.
-//
-#ifndef TEST_INTERFACE_HH
-#define TEST_INTERFACE_HH
-
-template< class Interface >
-void test_interface( void ){
-
- Interface::interface_name();
-
- typename Interface::gene_matrix A;
-
-
-
-
-
-}
-
-#endif