瀏覽代碼

python ext

Konstantin Ladutenko 6 年之前
父節點
當前提交
592900a0a3
共有 10 個文件被更改,包括 2193 次插入1210 次删除
  1. 9 1
      Makefile
  2. 3 3
      scattnlay.pyx
  3. 2 1
      src/nearfield.cc
  4. 62 15
      src/nmie-impl.hpp
  5. 2 2
      src/nmie.cc
  6. 9 5
      src/nmie.hpp
  7. 2 1
      src/py_nmie.cc
  8. 1 1
      src/py_nmie.h
  9. 1051 590
      src/scattnlay.cpp
  10. 1052 591
      src/scattnlay_mp.cpp

+ 9 - 1
Makefile

@@ -1,8 +1,9 @@
 PYTHON=`which python`
+PYTHON3=`which python3`
 CYTHON=`which cython`
 DESTDIR=/
 PROJECT=python-scattnlay
-VERSION=2.1
+VERSION=2.2  # compare with nmie.hpp 
 BUILDIR=$(CURDIR)/debian/$(PROJECT)
 SRCDIR=$(CURDIR)/src
 MULTIPREC=100
@@ -12,6 +13,8 @@ all:
 	@echo "make cython - Convert Cython code to C++"
 	@echo "make python_ext - Create Python extension using C++ code"
 	@echo "make cython_ext - Create Python extension using Cython code"
+	@echo "make python3_ext - Create Python3 extension using C++ code"
+	@echo "make cython3_ext - Create Python3 extension using Cython code"
 	@echo "make install - Install Python extension on local system"
 	@echo "make buildrpm - Generate a rpm package for Python extension"
 	@echo "make builddeb - Generate a deb package for Python extension"
@@ -35,6 +38,11 @@ python_ext: $(SRCDIR)/nmie.cc $(SRCDIR)/py_nmie.cc $(SRCDIR)/scattnlay.cpp $(SRC
 
 cython_ext: cython python_ext
 
+python3_ext: $(SRCDIR)/nmie.cc $(SRCDIR)/py_nmie.cc $(SRCDIR)/scattnlay.cpp $(SRCDIR)/scattnlay_mp.cpp
+	$(PYTHON3) setup.py build_ext --inplace
+
+cython3_ext: cython python3_ext
+
 install:
 	$(PYTHON) setup.py install --root $(DESTDIR) $(COMPILE)
 

+ 3 - 3
scattnlay.pyx

@@ -44,7 +44,7 @@ cdef inline double *npy2c(np.ndarray a):
 cdef extern from "py_nmie.h":
     cdef int ScattCoeffs(int L, int pl, vector[double] x, vector[complex] m, int nmax, double anr[], double ani[], double bnr[], double bni[])
     cdef int nMie(int L, int pl, vector[double] x, vector[complex] m, int nTheta, vector[double] Theta, int nmax, double *Qext, double *Qsca, double *Qabs, double *Qbk, double *Qpr, double *g, double *Albedo, double S1r[], double S1i[], double S2r[], double S2i[])
-    cdef int nField(int L, int pl, vector[double] x, vector[complex] m, int nmax, int nCoords, vector[double] Xp, vector[double] Yp, vector[double] Zp, double Erx[], double Ery[], double Erz[], double Eix[], double Eiy[], double Eiz[], double Hrx[], double Hry[], double Hrz[], double Hix[], double Hiy[], double Hiz[])
+    cdef int nField(int L, int pl, vector[double] x, vector[complex] m, int nmax, int mode_n, int mode_type, int nCoords, vector[double] Xp, vector[double] Yp, vector[double] Zp, double Erx[], double Ery[], double Erz[], double Eix[], double Eiy[], double Eiz[], double Hrx[], double Hry[], double Hrz[], double Hix[], double Hiy[], double Hiz[])
 
 def scattcoeffs(np.ndarray[np.float64_t, ndim = 2] x, np.ndarray[np.complex128_t, ndim = 2] m, np.int_t nmax, np.int_t pl = -1):
     cdef Py_ssize_t i
@@ -106,7 +106,7 @@ def scattnlay(np.ndarray[np.float64_t, ndim = 2] x, np.ndarray[np.complex128_t,
 
     return terms, Qext, Qsca, Qabs, Qbk, Qpr, g, Albedo, S1, S2
 
-def fieldnlay(np.ndarray[np.float64_t, ndim = 2] x, np.ndarray[np.complex128_t, ndim = 2] m, np.ndarray[np.float64_t, ndim = 2] coords, np.int_t nmax = -1, np.int_t pl = -1):
+def fieldnlay(np.ndarray[np.float64_t, ndim = 2] x, np.ndarray[np.complex128_t, ndim = 2] m, np.ndarray[np.float64_t, ndim = 2] coords, np.int_t nmax = -1, np.int_t mode_n = -1, np.int_t mode_type = -1, np.int_t pl = -1):
     cdef Py_ssize_t i
 
     cdef np.ndarray[np.int_t, ndim = 1] terms = np.zeros(x.shape[0], dtype = np.int)
@@ -141,7 +141,7 @@ def fieldnlay(np.ndarray[np.float64_t, ndim = 2] x, np.ndarray[np.complex128_t,
         Hiy = np.zeros(coords.shape[0], dtype = np.float64)
         Hiz = np.zeros(coords.shape[0], dtype = np.float64)
 
-        terms[i] = nField(x.shape[1], pl, x[i].copy('C'), m[i].copy('C'), nmax, coords.shape[0], coords[:, 0].copy('C'), coords[:, 1].copy('C'), coords[:, 2].copy('C'), npy2c(Erx), npy2c(Ery), npy2c(Erz), npy2c(Eix), npy2c(Eiy), npy2c(Eiz), npy2c(Hrx), npy2c(Hry), npy2c(Hrz), npy2c(Hix), npy2c(Hiy), npy2c(Hiz))
+        terms[i] = nField(x.shape[1], pl, x[i].copy('C'), m[i].copy('C'), nmax, mode_n, mode_type, coords.shape[0], coords[:, 0].copy('C'), coords[:, 1].copy('C'), coords[:, 2].copy('C'), npy2c(Erx), npy2c(Ery), npy2c(Erz), npy2c(Eix), npy2c(Eiy), npy2c(Eiz), npy2c(Hrx), npy2c(Hry), npy2c(Hrz), npy2c(Hix), npy2c(Hiy), npy2c(Hiz))
 
         E[i] = np.vstack((Erx.copy('C') + 1.0j*Eix.copy('C'), Ery.copy('C') + 1.0j*Eiy.copy('C'), Erz.copy('C') + 1.0j*Eiz.copy('C'))).transpose()
         H[i] = np.vstack((Hrx.copy('C') + 1.0j*Hix.copy('C'), Hry.copy('C') + 1.0j*Hiy.copy('C'), Hrz.copy('C') + 1.0j*Hiz.copy('C'))).transpose()

+ 2 - 1
src/nearfield.cc

@@ -237,7 +237,8 @@ int main(int argc, char *argv[]) {
       }
     }
 
-    nmie::nField(L, -1, x, m, -1, total_points, Xp, Yp, Zp, E, H);
+    nmie::nField(L, -1, x, m, -1, nmie::Modes::kAll, nmie::Modes::kAll,
+                 total_points, Xp, Yp, Zp, E, H);
 
     if (has_comment)
       printf("%6s\n", comment.c_str());

+ 62 - 15
src/nmie-impl.hpp

@@ -1003,19 +1003,33 @@ namespace nmie {
   //   Rho: Radial distance                                                           //
   //   Phi: Azimuthal angle                                                           //
   //   Theta: Polar angle                                                             //
+  //   mode_n: mode order.                                                            //
+  //          -1 - use all modes (all_)                                               //
+  //           1 - use dipole mode only                                               //
+  //           2 - use quadrupole mode only                                           //
+  //           ...                                                                    //
+  //   mode_type: only used when mode_n != -1                                         //
+  //          0 - electric only                                                       //
+  //          1 - magnetic only                                                       //
+  //                                                                                  //
   //                                                                                  //
   // Output parameters:                                                               //
   //   E, H: Complex electric and magnetic fields                                     //
   //**********************************************************************************//
   template <typename FloatType>
-  void MultiLayerMie<FloatType>::calcField(const FloatType Rho, const FloatType Theta, const FloatType Phi,
-                                std::vector<std::complex<FloatType> >& E, std::vector<std::complex<FloatType> >& H)  {
+  void MultiLayerMie<FloatType>::calcFieldByComponents(const FloatType Rho,
+                                const FloatType Theta, const FloatType Phi,
+                                const int mode_n, const int mode_type,
+                                std::vector<std::complex<FloatType> >& E,
+                                std::vector<std::complex<FloatType> >& H)  {
 
     std::complex<FloatType> c_zero(0.0, 0.0), c_i(0.0, 1.0), c_one(1.0, 0.0);
-    std::vector<std::complex<FloatType> > ipow = {c_one, c_i, -c_one, -c_i}; // Vector containing precomputed integer powers of i to avoid computation
+    // Vector containing precomputed integer powers of i to avoid computation
+    std::vector<std::complex<FloatType> > ipow = {c_one, c_i, -c_one, -c_i}; 
     std::vector<std::complex<FloatType> > M3o1n(3), M3e1n(3), N3o1n(3), N3e1n(3);
     std::vector<std::complex<FloatType> > M1o1n(3), M1e1n(3), N1o1n(3), N1e1n(3);
-    std::vector<std::complex<FloatType> > Psi(nmax_ + 1), D1n(nmax_ + 1), Zeta(nmax_ + 1), D3n(nmax_ + 1);
+    std::vector<std::complex<FloatType> > Psi(nmax_ + 1), D1n(nmax_ + 1),
+      Zeta(nmax_ + 1), D3n(nmax_ + 1);
     std::vector<FloatType> Pi(nmax_), Tau(nmax_);
 
     int l = 0;  // Layer number
@@ -1052,19 +1066,43 @@ namespace nmie {
       FloatType rn = static_cast<FloatType>(n1);
 
       // using BH 4.12 and 4.50
-      calcSpherHarm(Rho*ml, Theta, Phi, Psi[n1], D1n[n1], Pi[n], Tau[n], rn, M1o1n, M1e1n, N1o1n, N1e1n);
-      calcSpherHarm(Rho*ml, Theta, Phi, Zeta[n1], D3n[n1], Pi[n], Tau[n], rn, M3o1n, M3e1n, N3o1n, N3e1n);
+      calcSpherHarm(Rho*ml, Theta, Phi, Psi[n1], D1n[n1], Pi[n], Tau[n], rn,
+                    M1o1n, M1e1n, N1o1n, N1e1n);
+      calcSpherHarm(Rho*ml, Theta, Phi, Zeta[n1], D3n[n1], Pi[n], Tau[n], rn,
+                    M3o1n, M3e1n, N3o1n, N3e1n);
 
       // Total field in the lth layer: eqs. (1) and (2) in Yang, Appl. Opt., 42 (2003) 1710-1720
       std::complex<FloatType> En = ipow[n1 % 4]
 	*static_cast<FloatType>((rn + rn + 1.0)/(rn*rn + rn));
       for (int i = 0; i < 3; i++) {
-        // electric field E [V m - 1] = EF*E0
-        E[i] += En*(cln_[l][n]*M1o1n[i] - c_i*dln_[l][n]*N1e1n[i]
-              + c_i*aln_[l][n]*N3e1n[i] -     bln_[l][n]*M3o1n[i]);
-
-        H[i] += En*(-dln_[l][n]*M1e1n[i] - c_i*cln_[l][n]*N1o1n[i]
-              +  c_i*bln_[l][n]*N3o1n[i] +     aln_[l][n]*M3e1n[i]);
+        if (mode_n == Modes::kAll) {
+          // electric field E [V m - 1] = EF*E0
+          E[i] += En*(      cln_[l][n]*M1o1n[i] - c_i*dln_[l][n]*N1e1n[i]
+                      + c_i*aln_[l][n]*N3e1n[i] -     bln_[l][n]*M3o1n[i]);
+
+          H[i] += En*(     -dln_[l][n]*M1e1n[i] - c_i*cln_[l][n]*N1o1n[i]
+                      + c_i*bln_[l][n]*N3o1n[i] +     aln_[l][n]*M3e1n[i]);
+          continue;
+        }
+        if (n1 == mode_n) {
+          if (mode_type == Modes::kElectric) {
+            E[i] += En*( -c_i*dln_[l][n]*N1e1n[i]
+                        + c_i*aln_[l][n]*N3e1n[i]);
+
+            H[i] += En*(-dln_[l][n]*M1e1n[i]
+                        +aln_[l][n]*M3e1n[i]);
+            continue;
+          }
+          if (mode_type == Modes::kMagnetic) {
+            E[i] += En*(  cln_[l][n]*M1o1n[i]
+                        - bln_[l][n]*M3o1n[i]);
+
+            H[i] += En*( -c_i*cln_[l][n]*N1o1n[i]
+                        + c_i*bln_[l][n]*N3o1n[i]);
+            continue;
+          }
+        }
+        throw std::invalid_argument("Error! Unexpected mode for field evaluation!");
       }
     }  // end of for all n
 
@@ -1073,7 +1111,7 @@ namespace nmie {
     for (int i = 0; i < 3; i++) {
       H[i] = hffact*H[i];
     }
-   }  // end of MultiLayerMie::calcField(...)
+   }  // end of MultiLayerMie::calcFieldByComponents(...)
 
 
   //**********************************************************************************//
@@ -1091,6 +1129,14 @@ namespace nmie {
   //   ncoord: Number of coordinate points                                            //
   //   Coords: Array containing all coordinates where the complex electric and        //
   //           magnetic fields will be calculated                                     //
+  //   mode_n: mode order.                                                            //
+  //          -1 - use all modes (all_)                                               //
+  //           1 - use dipole mode only                                               //
+  //           2 - use quadrupole mode only                                           //
+  //           ...                                                                    //
+  //   mode_type: only used when mode_n != -1                                         //
+  //          0 - electric only                                                       //
+  //          1 - magnetic only                                                       //
   //                                                                                  //
   // Output parameters:                                                               //
   //   E, H: Complex electric and magnetic field at the provided coordinates          //
@@ -1099,7 +1145,8 @@ namespace nmie {
   //   Number of multipolar expansion terms used for the calculations                 //
   //**********************************************************************************//
   template <typename FloatType>
-  void MultiLayerMie<FloatType>::RunFieldCalculation() {
+  void MultiLayerMie<FloatType>::RunFieldCalculation(
+                                const int mode_n, const int mode_type) {
     FloatType Rho, Theta, Phi;
 
     // Calculate scattering coefficients an_ and bn_
@@ -1150,7 +1197,7 @@ namespace nmie {
       std::vector<std::complex<FloatType> > Es(3), Hs(3);
 
       // Do the actual calculation of electric and magnetic field
-      calcField(Rho, Theta, Phi, Es, Hs);
+      calcFieldByComponents(Rho, Theta, Phi, mode_n, mode_type, Es, Hs);
       for (int sph_coord = 0; sph_coord<3; ++sph_coord) {
         Es_[point][sph_coord] = Es[sph_coord];
         Hs_[point][sph_coord] = Hs[sph_coord];

+ 2 - 2
src/nmie.cc

@@ -288,7 +288,7 @@ namespace nmie {
   // Return value:                                                                    //
   //   Number of multipolar expansion terms used for the calculations                 //
   //**********************************************************************************//
-  int nField(const unsigned int L, const int pl, const std::vector<double>& x, const std::vector<std::complex<double> >& m, const int nmax, const unsigned int ncoord, const std::vector<double>& Xp_vec, const std::vector<double>& Yp_vec, const std::vector<double>& Zp_vec, std::vector<std::vector<std::complex<double> > >& E, std::vector<std::vector<std::complex<double> > >& H) {
+  int nField(const unsigned int L, const int pl, const std::vector<double>& x, const std::vector<std::complex<double> >& m, const int nmax, const int mode_n, const int mode_type, const unsigned int ncoord, const std::vector<double>& Xp_vec, const std::vector<double>& Yp_vec, const std::vector<double>& Zp_vec, std::vector<std::vector<std::complex<double> > >& E, std::vector<std::vector<std::complex<double> > >& H) {
     if (x.size() != L || m.size() != L)
       throw std::invalid_argument("Declared number of layers do not fit x and m!");
     if (Xp_vec.size() != ncoord || Yp_vec.size() != ncoord || Zp_vec.size() != ncoord
@@ -308,7 +308,7 @@ namespace nmie {
       ml_mie.SetFieldCoords({ConvertVector<FloatType>(Xp_vec),
 	    ConvertVector<FloatType>(Yp_vec),
 	    ConvertVector<FloatType>(Zp_vec) });
-      ml_mie.RunFieldCalculation();
+      ml_mie.RunFieldCalculation(mode_n, mode_type);
       E = ConvertComplexVectorVector<double>(ml_mie.GetFieldE());
       H = ConvertComplexVectorVector<double>(ml_mie.GetFieldH());
 

+ 9 - 5
src/nmie.hpp

@@ -27,7 +27,7 @@
 //    along with this program.  If not, see <http://www.gnu.org/licenses/>.         //
 //**********************************************************************************//
 
-#define VERSION "2.0"
+#define VERSION "2.2"  //Compare with Makefile
 #include <array>
 #include <complex>
 #include <cstdlib>
@@ -40,7 +40,10 @@ namespace nmie {
   int nMie(const unsigned int L, std::vector<double>& x, std::vector<std::complex<double> >& m, const unsigned int nTheta, std::vector<double>& Theta, double *Qext, double *Qsca, double *Qabs, double *Qbk, double *Qpr, double *g, double *Albedo, std::vector<std::complex<double> >& S1, std::vector<std::complex<double> >& S2);
   int nMie(const unsigned int L, const int pl, std::vector<double>& x, std::vector<std::complex<double> >& m, const unsigned int nTheta, std::vector<double>& Theta, double *Qext, double *Qsca, double *Qabs, double *Qbk, double *Qpr, double *g, double *Albedo, std::vector<std::complex<double> >& S1, std::vector<std::complex<double> >& S2);
   int nMie(const unsigned int L, std::vector<double>& x, std::vector<std::complex<double> >& m, const unsigned int nTheta, std::vector<double>& Theta, const int nmax, double *Qext, double *Qsca, double *Qabs, double *Qbk, double *Qpr, double *g, double *Albedo, std::vector<std::complex<double> >& S1, std::vector<std::complex<double> >& S2);
-  int nField(const unsigned int L, const int pl, const std::vector<double>& x, const std::vector<std::complex<double> >& m, const int nmax, const unsigned int ncoord, const std::vector<double>& Xp, const std::vector<double>& Yp, const std::vector<double>& Zp, std::vector<std::vector<std::complex<double> > >& E, std::vector<std::vector<std::complex<double> > >& H);
+  int nField(const unsigned int L, const int pl, const std::vector<double>& x, const std::vector<std::complex<double> >& m, const int nmax, const int mode_n, const int mode_type, const unsigned int ncoord, const std::vector<double>& Xp, const std::vector<double>& Yp, const std::vector<double>& Zp, std::vector<std::vector<std::complex<double> > >& E, std::vector<std::vector<std::complex<double> > >& H);
+
+  // constants for field evaluation
+  enum Modes {kAll = -1, kElectric = 0, kMagnetic = 1};
 
   template <typename FloatType = double>
   class MultiLayerMie {    
@@ -53,7 +56,7 @@ namespace nmie {
     const double mu_ = 4.0*PI_*1.0e-7;
     // Run calculation
     void RunMieCalculation();
-    void RunFieldCalculation();
+    void RunFieldCalculation(const int mode_n=Modes::kAll, const int mode_type=Modes::kAll);
     void calcScattCoeffs();
 
     // Return calculation results
@@ -152,8 +155,9 @@ namespace nmie {
                        std::vector<std::complex<FloatType> >& Mo1n, std::vector<std::complex<FloatType> >& Me1n, 
                        std::vector<std::complex<FloatType> >& No1n, std::vector<std::complex<FloatType> >& Ne1n);
 
-    void calcField(const FloatType Rho, const FloatType Theta, const FloatType Phi,
-                   std::vector<std::complex<FloatType> >& E, std::vector<std::complex<FloatType> >& H);
+    void calcFieldByComponents(const FloatType Rho, const FloatType Theta, const FloatType Phi,
+                               const int mode_n, const int mode_type,
+                               std::vector<std::complex<FloatType> >& E, std::vector<std::complex<FloatType> >& H);
 
     bool isExpCoeffsCalc_ = false;
     bool isScaCoeffsCalc_ = false;

+ 2 - 1
src/py_nmie.cc

@@ -83,6 +83,7 @@ int nMie(const int L, const int pl, std::vector<double>& x, std::vector<std::com
 // This is a workaround because I have not been able to return the results using 
 // std::vector<std::complex<double> >
 int nField(const int L, const int pl, std::vector<double>& x, std::vector<std::complex<double> >& m, const int nmax,
+           const int mode_n, const int mode_type,
            const int nCoords, std::vector<double>& Xp, std::vector<double>& Yp, std::vector<double>& Zp,
            double Erx[], double Ery[], double Erz[], double Eix[], double Eiy[], double Eiz[],
            double Hrx[], double Hry[], double Hrz[], double Hix[], double Hiy[], double Hiz[]) {
@@ -96,7 +97,7 @@ int nField(const int L, const int pl, std::vector<double>& x, std::vector<std::c
     H[i].resize(3);
   }
 
-  result = nmie::nField(L, pl, x, m, nmax, nCoords, Xp, Yp, Zp, E, H);
+  result = nmie::nField(L, pl, x, m, nmax, mode_n, mode_type, nCoords, Xp, Yp, Zp, E, H);
 
   for (i = 0; i < nCoords; i++) {
     Erx[i] = E[i][0].real();

+ 1 - 1
src/py_nmie.h

@@ -36,7 +36,7 @@ int nMie(const int L, const int pl, std::vector<double>& x, std::vector<std::com
          double *Qext, double *Qsca, double *Qabs, double *Qbk, double *Qpr, double *g, double *Albedo,
 		 double S1r[], double S1i[], double S2r[], double S2i[]);
 
-int nField(const int L, const int pl, std::vector<double>& x, std::vector<std::complex<double> >& m, const int nmax,
+int nField(const int L, const int pl, std::vector<double>& x, std::vector<std::complex<double> >& m, const int nmax, const int mode_n, const int mode_type,
            const int nCoords, std::vector<double>& Xp, std::vector<double>& Yp, std::vector<double>& Zp,
            double Erx[], double Ery[], double Erz[], double Eix[], double Eiy[], double Eiz[],
            double Hrx[], double Hry[], double Hrz[], double Hix[], double Hiy[], double Hiz[]);

文件差異過大導致無法顯示
+ 1051 - 590
src/scattnlay.cpp


文件差異過大導致無法顯示
+ 1052 - 591
src/scattnlay_mp.cpp


部分文件因文件數量過多而無法顯示